]>
https://gitweb.dealii.org/ - dealii.git/log
David Wells [Mon, 7 Jun 2021 18:06:54 +0000 (14:06 -0400)]
Use initlog in some tests.
We forgot to call mpi_initlog() in these tests, which caused the tests to
compare stderr + stdout as output - this is why we had a bunch of problems with
testers collecting additional MPI error output.
David Wells [Mon, 7 Jun 2021 11:11:26 +0000 (07:11 -0400)]
Merge pull request #12393 from peterrum/simplify_compute_point_to_point_communication_pattern
Simplify compute_point_to_point_communication_pattern() and compute_n_point_to_point_communications()
Peter Munch [Mon, 7 Jun 2021 04:14:42 +0000 (06:14 +0200)]
Merge pull request #11577 from gassmoeller/particle_vector_container
Store particles in vector container
Rene Gassmoeller [Sun, 6 Jun 2021 21:12:44 +0000 (17:12 -0400)]
Add changelog entry
Martin Kronbichler [Sun, 6 Jun 2021 19:51:39 +0000 (21:51 +0200)]
Merge pull request #12392 from peterrum/cellwise_inserve_mass_factory
Refactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMassFactory
Rene Gassmoeller [Sun, 6 Jun 2021 17:39:38 +0000 (13:39 -0400)]
Address comments
Rene Gassmoeller [Wed, 9 Dec 2020 23:59:29 +0000 (18:59 -0500)]
Store particles in a vector
Peter Munch [Sun, 6 Jun 2021 15:11:20 +0000 (17:11 +0200)]
Simplify compute_point_to_point_communication_pattern() and compute_n_point_to_point_communications()
Peter Munch [Sat, 5 Jun 2021 15:07:04 +0000 (17:07 +0200)]
Refactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMassFactory
Martin Kronbichler [Sat, 5 Jun 2021 05:59:20 +0000 (07:59 +0200)]
Merge pull request #12377 from peterrum/part_simplify
Simplify workflow of repartitioning
Peter Munch [Tue, 1 Jun 2021 20:34:57 +0000 (22:34 +0200)]
Simplify workflow of repartitioning
Conflicts:
source/grid/tria_description.cc
Peter Munch [Sat, 5 Jun 2021 03:35:33 +0000 (05:35 +0200)]
Merge pull request #12357 from peterrum/create_geometric_coarsening_sequence_new_const
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence(): add parameters
Peter Munch [Sat, 5 Jun 2021 03:35:23 +0000 (05:35 +0200)]
Merge pull request #12390 from peterrum/transform_from_q_points_to_basis
CellwiseInverseMassMatrix::transform_from_q_points_to_basis() extension
Peter Munch [Fri, 4 Jun 2021 20:23:15 +0000 (22:23 +0200)]
Merge pull request #12389 from masterleinad/remove_deprecated_vector_tools
Remove deprecated VectorTools functions
Peter Munch [Sun, 30 May 2021 10:58:05 +0000 (12:58 +0200)]
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence(): make it optional to coarsen input tria
Peter Munch [Fri, 4 Jun 2021 17:22:48 +0000 (19:22 +0200)]
CellwiseInverseMassMatrix::transform_from_q_points_to_basis: for degree = -1 and degree+1!=q_points_1d
Daniel Arndt [Fri, 4 Jun 2021 14:58:24 +0000 (10:58 -0400)]
Remove deprecated VectorTools
Daniel Arndt [Fri, 4 Jun 2021 13:21:29 +0000 (09:21 -0400)]
Merge pull request #12386 from masterleinad/remove_deprecated_fe_tools_l_to_h_numbering
Remove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering
Peter Munch [Fri, 4 Jun 2021 12:28:01 +0000 (14:28 +0200)]
Merge pull request #12387 from peterrum/reduce_fix
Fix ambiguous call in Utilities::MPI::all_reduce
Martin Kronbichler [Fri, 4 Jun 2021 11:27:37 +0000 (13:27 +0200)]
Merge pull request #12379 from simonsticko/fe_q_support_points_dim_1
Add a 0-dimensional face support point on FE_Q<1>.
Martin Kronbichler [Fri, 4 Jun 2021 10:56:22 +0000 (12:56 +0200)]
Merge pull request #12384 from masterleinad/remove_deprecated_cell_accessor_active
Remove deprecated CellAccessor::active()
Martin Kronbichler [Fri, 4 Jun 2021 10:55:47 +0000 (12:55 +0200)]
Merge pull request #12385 from masterleinad/remove_deprecated_vectorized_array_n_array_elements
Remove deprecated VectorizedArray::n_array_elements
Peter Munch [Fri, 4 Jun 2021 10:47:30 +0000 (12:47 +0200)]
Fix ambiguous call in Utilities::MPI::all_reduce
Daniel Arndt [Thu, 3 Jun 2021 19:54:57 +0000 (15:54 -0400)]
Remove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering
Timo Heister [Thu, 3 Jun 2021 18:48:55 +0000 (14:48 -0400)]
Merge pull request #12383 from peterrum/DEAL_II_DEPRECATED_EARLY_user
Allow DEAL_II_DEPRECATED_EARLY in user code
Daniel Arndt [Thu, 3 Jun 2021 16:18:18 +0000 (12:18 -0400)]
Remove deprecated VectorizedArray::n_array_elements
Daniel Arndt [Thu, 3 Jun 2021 13:40:25 +0000 (09:40 -0400)]
Remove deprecated CellAccessor::active()
Peter Munch [Thu, 3 Jun 2021 11:19:44 +0000 (13:19 +0200)]
Allow DEAL_II_DEPRECATED_EARLY in user code
Simon Sticko [Wed, 2 Jun 2021 13:24:37 +0000 (15:24 +0200)]
Add a 0-dimensional face support point on FE_Q<1>.
In several places QProjector is used to map the dim-1 dimensional face
support points to dim dimensional points, but this is not possible in
1D because unit_face_support_points currently contains no points for
FE_Q<1>. Add a single 0-dimensional point to unit_face_support_points
to fix this.
David Wells [Thu, 3 Jun 2021 02:40:17 +0000 (22:40 -0400)]
Merge pull request #12382 from masterleinad/remove_deprecated_first_cell
Remove DataOut::first_cell() and DataOut::next_cell()
Daniel Arndt [Wed, 2 Jun 2021 15:56:17 +0000 (11:56 -0400)]
Remove DataOut::first_cell() and DataOut::next_cell()
Martin Kronbichler [Wed, 2 Jun 2021 08:01:46 +0000 (10:01 +0200)]
Merge pull request #12376 from masterleinad/remove_deprecated_mg_transfer_build_matrices
Remove deprecated multigrid transfer build_matrices() functions
Martin Kronbichler [Wed, 2 Jun 2021 08:01:08 +0000 (10:01 +0200)]
Merge pull request #12371 from peterrum/pdt_subcomm
TriangulationDescription::Utilities::create_description_from_triangulation(): allow subcommunicator in p::d::T
Peter Munch [Tue, 1 Jun 2021 20:13:32 +0000 (22:13 +0200)]
Merge pull request #12356 from peterrum/create_geometric_coarsening_sequence_new
Add new version of MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence() that takes partitioner
David Wells [Tue, 1 Jun 2021 20:12:20 +0000 (16:12 -0400)]
Merge pull request #12375 from peterrum/mg_transfer_global_coarsening_mesh_type
Remove MeshType from mg_transfer_global_coarsening.templates.h
Daniel Arndt [Tue, 1 Jun 2021 17:30:53 +0000 (13:30 -0400)]
Remove deprecated multigrid transfer build_matrices() functions
Peter Munch [Tue, 1 Jun 2021 08:27:04 +0000 (10:27 +0200)]
TriangulationDescription::Utilities::create_description_from_triangulation(): allow subcommunicator in pdt
Peter Munch [Sun, 30 May 2021 10:17:09 +0000 (12:17 +0200)]
Add new version of MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence() that takes partitioner
Conflicts:
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
Martin Kronbichler [Tue, 1 Jun 2021 16:49:13 +0000 (18:49 +0200)]
Merge pull request #12346 from peterrum/create_geometric_coarsening_sequence_trias
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence() for additional types of triangulations
Peter Munch [Tue, 1 Jun 2021 16:43:47 +0000 (18:43 +0200)]
Merge pull request #12373 from masterleinad/remove_deprecated_dof_tools_count_dofs_per
Remove deprecated versions of the DoFTools::count_dofs_per_*()
Peter Munch [Tue, 1 Jun 2021 16:41:08 +0000 (18:41 +0200)]
Remove MeshType from mg_transfer_global_coarsening.templates.h
Peter Munch [Tue, 1 Jun 2021 16:28:39 +0000 (18:28 +0200)]
Merge pull request #12280 from peterrum/p_transfer_coarse_grid
Enable p-transfer on coarse grid
David Wells [Tue, 1 Jun 2021 16:20:19 +0000 (12:20 -0400)]
Merge pull request #12372 from simonsticko/face_interpolation_bernstein_2_fe_q
Implement face interpolation between FE_Bernstein and elements with support points.
David Wells [Tue, 1 Jun 2021 15:58:33 +0000 (11:58 -0400)]
Merge pull request #12342 from marcfehling/doc-refinement
Minor doc update for `hp::Refinement::predict_error()`.
Daniel Arndt [Tue, 1 Jun 2021 14:17:27 +0000 (10:17 -0400)]
Remove deprecated versions of the DoFTools::count_dofs_per_*()
Martin Kronbichler [Tue, 1 Jun 2021 13:37:58 +0000 (15:37 +0200)]
Merge pull request #12302 from nicola-giuliani/add-changes-and-test
added change log and test
Nicola Giuliani [Tue, 1 Jun 2021 09:09:34 +0000 (11:09 +0200)]
Update tests/grid/tria_clear_user_data.cc
Co-authored-by: Martin Kronbichler <kronbichler@lnm.mw.tum.de>
Simon Sticko [Tue, 1 Jun 2021 07:01:01 +0000 (09:01 +0200)]
Implement face interpolation between FE_Bernstein and elements with support points.
By using the implementation of get_face_interpolation_matrix in the
base class (FE_Q_Base) when the incoming element isn't a Bernstein
element.
Martin Kronbichler [Tue, 1 Jun 2021 07:33:06 +0000 (09:33 +0200)]
Merge pull request #12338 from masterleinad/remove_deprecated_dof_tools_extract_+dofs
Remove deprecated DoFTools::extract_*dofs overloads
Martin Kronbichler [Tue, 1 Jun 2021 07:30:27 +0000 (09:30 +0200)]
Merge pull request #12348 from peterrum/partition_policies
Introduce partitioning policies
Peter Munch [Sat, 29 May 2021 15:14:55 +0000 (17:14 +0200)]
Introduce partition policies
Matthias Maier [Mon, 31 May 2021 21:50:36 +0000 (16:50 -0500)]
Merge pull request #12368 from jppelteret/changelogs_02
Add changelog entry for step-74
Martin Kronbichler [Mon, 31 May 2021 21:36:27 +0000 (23:36 +0200)]
Merge pull request #12366 from marcfehling/fix-step-75
Bugfix step-75: Call `get_fe()` only on locally owned cells.
Martin Kronbichler [Mon, 31 May 2021 21:36:08 +0000 (23:36 +0200)]
Merge pull request #12365 from peterrum/boost_point
Fix creating of boost point
Martin Kronbichler [Mon, 31 May 2021 21:35:57 +0000 (23:35 +0200)]
Merge pull request #12360 from simonsticko/face_interpolation_assert
A better assert in FE_Q_Base::get_subface_interpolation_matrix
Jean-Paul Pelteret [Mon, 31 May 2021 18:50:49 +0000 (20:50 +0200)]
Add changelog entry for step-74
Marc Fehling [Mon, 31 May 2021 17:59:25 +0000 (11:59 -0600)]
Bugfix step-75: Call `get_fe()` only on locally owned cells.
Peter Munch [Mon, 31 May 2021 16:34:01 +0000 (18:34 +0200)]
Fix creating of boost point
Matthias Maier [Mon, 31 May 2021 15:06:59 +0000 (10:06 -0500)]
Merge pull request #12358 from tamiko/avoid_underlinkage
Avoid underlinkage with OpenMPI on Debian/Ubuntu
Martin Kronbichler [Mon, 31 May 2021 13:28:08 +0000 (15:28 +0200)]
Merge pull request #12363 from peterrum/rpe_race_condition
RemotePointEvaluation: fix race condition if called multiple times
Martin Kronbichler [Mon, 31 May 2021 12:59:49 +0000 (14:59 +0200)]
Merge pull request #12331 from vachan-potluri/fe_dgq_legendre_shape_function_ordering_doc
Add documentation about shape function ordering for `FE_DGQLegendre`
Peter Munch [Mon, 31 May 2021 12:44:08 +0000 (14:44 +0200)]
Merge pull request #12361 from kronbichler/remove_changelog
Remove changelog entry about taskflow
Peter Munch [Mon, 31 May 2021 11:35:55 +0000 (13:35 +0200)]
RemotePointEvaluation: fix race condition if called multiple times
Simon Sticko [Fri, 28 May 2021 16:00:42 +0000 (18:00 +0200)]
A better assert in FE_Q_Base::get_subface_interpolation_matrix
The previous assert checked that the element derived from FE_Q_Base
or FE_SimplexPoly. This isn't right for FE_Bernstein, which derives
from FE_Q_Base, but doesn't have support points. Instead of throwing
ExcInterpolationNotImplemented, using FE_Bernstein resulted in an
exception which was hard to understand. Change the assert so that it
checks if the incoming element has support points on the face and has
the right number of components.
Martin Kronbichler [Mon, 31 May 2021 09:30:44 +0000 (11:30 +0200)]
Remove changelog entry about taskflow
Martin Kronbichler [Mon, 31 May 2021 09:26:09 +0000 (11:26 +0200)]
Merge pull request #12330 from peterrum/reduce
Implement Utilities::MPI::reduce()
Martin Kronbichler [Mon, 31 May 2021 09:25:37 +0000 (11:25 +0200)]
Merge pull request #12353 from peterrum/rpe_rtree_level
RemotePointEvaluation: make RTree-level parameter
Martin Kronbichler [Mon, 31 May 2021 09:25:20 +0000 (11:25 +0200)]
Merge pull request #12352 from peterrum/find_active_cell_around_point_outside
GridTools::find_active_cell_around_point(): improve detection if point is outside of domain
Martin Kronbichler [Mon, 31 May 2021 09:22:56 +0000 (11:22 +0200)]
Merge pull request #12312 from peterrum/create_description_from_triangulation_rep
Add TriangulationDescription::Utilities::create_description_from_triangulation() version to repartition p:d:T
Matthias Maier [Sun, 30 May 2021 20:24:50 +0000 (15:24 -0500)]
Avoid underlinkage with OpenMPI on Debian/Ubuntu
Make sure that we do not run into underlinking on Debian/Ubuntu systems
with lld / ld.gold and missing libopen-pal.so on the link line
Peter Munch [Sat, 29 May 2021 20:58:31 +0000 (22:58 +0200)]
GridTools::find_active_cell_around_point(): improve detection if point is outside of domain
Peter Munch [Sat, 29 May 2021 12:56:44 +0000 (14:56 +0200)]
Add TriangulationDescription::Utilities::create_description_from_triangulation() version to repartition p:d:T
Peter Munch [Sun, 30 May 2021 09:07:14 +0000 (11:07 +0200)]
Merge pull request #12333 from peterrum/point_gradients
Introduce VectorTools::point_gradients()
Peter Munch [Sun, 30 May 2021 06:52:56 +0000 (08:52 +0200)]
Introduce VectorTools::point_gradients()
Peter Munch [Sun, 30 May 2021 06:38:50 +0000 (08:38 +0200)]
Merge pull request #12311 from peterrum/create_description_from_triangulation_clean
Clean up TriangulationDescription::Utilities::create_description_from_triangulation()
Martin Kronbichler [Sun, 30 May 2021 06:27:27 +0000 (08:27 +0200)]
Merge pull request #12351 from masterleinad/remove_deprecated_timer_enter_section
Remove deprecated Timer::enter/exit_section
Marc Fehling [Sun, 30 May 2021 05:31:14 +0000 (23:31 -0600)]
Merge pull request #12332 from peterrum/point_values
Rename VectorTools::evaluate_at_points() -> VectorTools::point_values()
Peter Munch [Fri, 28 May 2021 06:46:20 +0000 (08:46 +0200)]
Rename VectorTools::evaluate_at_points() -> VectorTools::point_values()
Marc Fehling [Sun, 30 May 2021 04:53:51 +0000 (22:53 -0600)]
Merge pull request #12350 from peterrum/fe_eval_bool_dep
Early deprecate functions in FEEvaluation
Marc Fehling [Sun, 30 May 2021 04:42:23 +0000 (22:42 -0600)]
Merge pull request #12347 from peterrum/pst_copy_triangulation_cast
Fix a dynamic cast in psT::copy_triangulation()
Daniel Arndt [Sat, 29 May 2021 21:51:55 +0000 (17:51 -0400)]
Update include/deal.II/base/timer.h
Co-authored-by: Martin Kronbichler <kronbichler@lnm.mw.tum.de>
Peter Munch [Sat, 29 May 2021 21:12:51 +0000 (23:12 +0200)]
RemotePointEvaluation: make RTree-level parameter
Daniel Arndt [Sat, 29 May 2021 17:09:41 +0000 (13:09 -0400)]
Remove deprecated Timer::enter/exit_section
Peter Munch [Sat, 29 May 2021 15:33:42 +0000 (17:33 +0200)]
Early deprecate functions in FEEvaluation
Daniel Arndt [Sat, 29 May 2021 15:21:50 +0000 (11:21 -0400)]
Improve documentation
Peter Munch [Sat, 29 May 2021 13:36:34 +0000 (15:36 +0200)]
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence() for additional types of triangulations
Peter Munch [Sat, 29 May 2021 13:43:09 +0000 (15:43 +0200)]
Fix a dynamic cast in psT::copy_triangulation()
Peter Munch [Wed, 26 May 2021 11:27:45 +0000 (13:27 +0200)]
Clean up TriangulationDescription::Utilities::create_description_from_triangulation()
Peter Munch [Sat, 29 May 2021 09:23:41 +0000 (11:23 +0200)]
Merge pull request #12344 from kronbichler/fix_interpolate_to_mg
Bugfix in MGTwoLevelTransfer::interpolate: forgot to copy vector
Martin Kronbichler [Sat, 29 May 2021 07:50:39 +0000 (09:50 +0200)]
Merge pull request #12335 from simonsticko/dof_cell_accessor_no_except
Remove noexcept on DoFAccessor move constructor and assignment operator
Martin Kronbichler [Sat, 29 May 2021 07:44:20 +0000 (09:44 +0200)]
Test basic ability of interpolate
Martin Kronbichler [Sat, 29 May 2021 07:43:49 +0000 (09:43 +0200)]
Bugfix in MGTwoLevelTransfer::interpolate: forgot to copy vector
Vachan Potluri [Sat, 29 May 2021 05:10:38 +0000 (10:40 +0530)]
Move trailing backslash to next line
Marc Fehling [Fri, 28 May 2021 21:46:08 +0000 (15:46 -0600)]
Minor doc update for `hp::Refinement::predict_error()`.
Simon Sticko [Fri, 28 May 2021 09:42:10 +0000 (11:42 +0200)]
Remove noexcept on DoFAccessor move constructor and assignment operator
To avoid a compilation error with clang 6.0.0
Daniel Arndt [Fri, 28 May 2021 14:34:15 +0000 (10:34 -0400)]
Remove deprecated DoFTools::extract_*dofs
Daniel Arndt [Fri, 28 May 2021 14:00:38 +0000 (10:00 -0400)]
Merge pull request #12301 from peterrum/level_mg_handler_remove
Remove MatrixFree::AdditionalData::level_mg_handler
Vachan Potluri [Fri, 28 May 2021 12:35:31 +0000 (18:05 +0530)]
Remove trailing white space
Martin Kronbichler [Fri, 28 May 2021 11:48:12 +0000 (13:48 +0200)]
Merge pull request #12323 from bangerth/doc
Minor doc improvement.
Peter Munch [Fri, 28 May 2021 07:54:03 +0000 (09:54 +0200)]
Merge pull request #12314 from masterleinad/remove_cudawrappers_feevaluation_overloads
Remove CUDAWrappers::FEEvaluation overloads taking dof index or quadrature point
In the beginning the Universe was created. This has made a lot of
people very angry and has been widely regarded as a bad move.
Douglas Adams
Typeset in
Trocchi and Trocchi Bold Sans Serif.