]> https://gitweb.dealii.org/ - dealii.git/log
dealii.git
3 years agoMerge pull request #12410 from jppelteret/fe_interface_values_01
Martin Kronbichler [Tue, 8 Jun 2021 18:28:47 +0000 (20:28 +0200)]
Merge pull request #12410 from jppelteret/fe_interface_values_01

Add FEInterfaceValues::quadrature_point_indices() to support range based loops

3 years agoMerge pull request #12407 from simonsticko/face_interpolation_1D
Martin Kronbichler [Tue, 8 Jun 2021 17:48:58 +0000 (19:48 +0200)]
Merge pull request #12407 from simonsticko/face_interpolation_1D

Enable get_face_interpolation_matrix() in 1D on FE_Q and FE_Bernstein

3 years agoAdd FEInterfaceValues::quadrature_point_indices() to support range based loops 12410/head
Jean-Paul Pelteret [Tue, 8 Jun 2021 14:23:55 +0000 (16:23 +0200)]
Add FEInterfaceValues::quadrature_point_indices() to support range based loops

3 years agoRename test face_interpolation_fe_Bernstein_2_fe_q.cc 12407/head
Simon Sticko [Tue, 8 Jun 2021 11:18:24 +0000 (13:18 +0200)]
Rename test face_interpolation_fe_Bernstein_2_fe_q.cc

Remove the suffix "_2_fe_q" in the filename, since it now tests both
the interpolation FE_Bernstein to Fe_Bernstein and FE_Bernstein to
FE_Q.

3 years agoEnable get_face_interpolation_matrix() in 1D on FE_Q and FE_Bernstein
Simon Sticko [Tue, 8 Jun 2021 07:42:28 +0000 (09:42 +0200)]
Enable get_face_interpolation_matrix() in 1D on FE_Q and FE_Bernstein

Currently, get_face_interpolation_matrix() on FE_Q and FE_Bernstein
throws an ExcImpossibleInDim(1) exception in 1D. This is strange
because the interpolation matrix should just be a 1-by-1 unit matrix.
Remove the dim > 1 assert in FE_Q_base and FE_Bernstein to fix this
and modify two tests to check that it works.

3 years agoMerge pull request #12404 from drwells/gcc11-simplex-p-warnings-2
David Wells [Tue, 8 Jun 2021 11:11:05 +0000 (07:11 -0400)]
Merge pull request #12404 from drwells/gcc11-simplex-p-warnings-2

Fix another GCC11 warning.

3 years agoMerge pull request #12406 from marcfehling/pack-unpack
David Wells [Tue, 8 Jun 2021 02:37:49 +0000 (22:37 -0400)]
Merge pull request #12406 from marcfehling/pack-unpack

Minor changes to `Utilities::unpack`.

3 years agoMerge pull request #12398 from bergbauer/exodusii
David Wells [Tue, 8 Jun 2021 02:34:30 +0000 (22:34 -0400)]
Merge pull request #12398 from bergbauer/exodusii

Add grid reordering to read_exodusii function

3 years agoMerge pull request #12405 from masterleinad/remove_remaining_deprecations_9_2
Marc Fehling [Tue, 8 Jun 2021 00:22:32 +0000 (18:22 -0600)]
Merge pull request #12405 from masterleinad/remove_remaining_deprecations_9_2

Remove remaining deprecations in release 9.2

3 years agoMerge pull request #12399 from masterleinad/remove_deprecated_feseriers_constructors
Marc Fehling [Tue, 8 Jun 2021 00:19:49 +0000 (18:19 -0600)]
Merge pull request #12399 from masterleinad/remove_deprecated_feseriers_constructors

Remove deprecated FESeries::Fourier and FESeries::Legendre constructors

3 years agoMerge pull request #12394 from bangerth/checks
Marc Fehling [Tue, 8 Jun 2021 00:18:28 +0000 (18:18 -0600)]
Merge pull request #12394 from bangerth/checks

Simplify the code that leads to an assertion.

3 years agoMerge pull request #12400 from drwells/virtual-dtor
Marc Fehling [Tue, 8 Jun 2021 00:17:10 +0000 (18:17 -0600)]
Merge pull request #12400 from drwells/virtual-dtor

Mark a destructor as virtual.

3 years agoMerge pull request #12403 from masterleinad/remove_deprecated_compute_vertices_with_g...
Marc Fehling [Tue, 8 Jun 2021 00:16:05 +0000 (18:16 -0600)]
Merge pull request #12403 from masterleinad/remove_deprecated_compute_vertices_with_ghost_neighbors

Remove deprecated TriangulationBase::compute_vertices_with_ghost_neighbors()

3 years agoAdd `constexpr` to type check. 12406/head
Marc Fehling [Mon, 7 Jun 2021 20:07:12 +0000 (14:07 -0600)]
Add `constexpr` to type check.

3 years agoMerge pull request #12397 from bangerth/66
David Wells [Mon, 7 Jun 2021 21:15:23 +0000 (17:15 -0400)]
Merge pull request #12397 from bangerth/66

Minor edits to step-66.

3 years agoFix another GCC11 warning. 12404/head
David Wells [Mon, 7 Jun 2021 18:12:12 +0000 (14:12 -0400)]
Fix another GCC11 warning.

3 years agoRemove remaining deprecations in release 9.2 12405/head
Daniel Arndt [Mon, 7 Jun 2021 18:53:35 +0000 (14:53 -0400)]
Remove remaining deprecations in release 9.2

3 years agoMerge pull request #12396 from bangerth/tut-graph
Timo Heister [Mon, 7 Jun 2021 19:01:22 +0000 (15:01 -0400)]
Merge pull request #12396 from bangerth/tut-graph

Reduce the width of the tutorial graph by a little bit.

3 years agoMerge pull request #12391 from marcfehling/hp-fevaluesbase
Wolfgang Bangerth [Mon, 7 Jun 2021 18:44:58 +0000 (12:44 -0600)]
Merge pull request #12391 from marcfehling/hp-fevaluesbase

Make `hp::FEValuesBase` derive from `Subscriptor`.

3 years agoRemove deprecated TriangulationBase::compute_vertices_with_ghost_neighbors() 12403/head
Daniel Arndt [Mon, 7 Jun 2021 17:03:06 +0000 (13:03 -0400)]
Remove deprecated TriangulationBase::compute_vertices_with_ghost_neighbors()

3 years agoMerge pull request #12388 from JPmoep/master
David Wells [Mon, 7 Jun 2021 17:10:50 +0000 (13:10 -0400)]
Merge pull request #12388 from JPmoep/master

Add AssertIndexRange for FEPointEvaluation

3 years agoSimplify the code that leads to an assertion. 12394/head
Wolfgang Bangerth [Mon, 7 Jun 2021 15:38:28 +0000 (09:38 -0600)]
Simplify the code that leads to an assertion.

We convert integers to doubles so that we can run MPI::MinMaxAvg and then compare
the min against the max. We do this comparison with a tolerance, but that is
unnecessary: If the integer representations are the same, then so are the
floating point representations, bit-by-bit.

3 years agoMark a destructor as virtual. 12400/head
David Wells [Mon, 7 Jun 2021 17:00:48 +0000 (13:00 -0400)]
Mark a destructor as virtual.

3 years agoRemove deprecated FESeries::Fourier and FESeries::Legendre constructors 12399/head
Daniel Arndt [Mon, 7 Jun 2021 16:09:18 +0000 (12:09 -0400)]
Remove deprecated FESeries::Fourier and FESeries::Legendre constructors

3 years agoMinor edits to step-66. 12397/head
Wolfgang Bangerth [Mon, 7 Jun 2021 16:08:06 +0000 (10:08 -0600)]
Minor edits to step-66.

3 years agoReduce the width of the tutorial graph by a little bit. 12396/head
Wolfgang Bangerth [Mon, 7 Jun 2021 16:07:40 +0000 (10:07 -0600)]
Reduce the width of the tutorial graph by a little bit.

More work is necessary, though.

3 years agoMerge pull request #12381 from masterleinad/require_mpi_for_trilinos
David Wells [Mon, 7 Jun 2021 15:50:26 +0000 (11:50 -0400)]
Merge pull request #12381 from masterleinad/require_mpi_for_trilinos

Require MPI for Trilinos

3 years agoAdd grid reordering to read_exodusii function 12398/head
Maximilian Bergbauer [Mon, 7 Jun 2021 14:59:12 +0000 (16:59 +0200)]
Add grid reordering to read_exodusii function

3 years agoAdd AssertIndexRange for FEPointEvaluation 12388/head
Judith Pauen [Fri, 4 Jun 2021 15:03:51 +0000 (17:03 +0200)]
Add AssertIndexRange for FEPointEvaluation

3 years agoMerge pull request #12393 from peterrum/simplify_compute_point_to_point_communication...
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()

3 years agoMerge pull request #11577 from gassmoeller/particle_vector_container
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

3 years agoMake `hp::FEValuesBase` derive from `Subscriptor`. 12391/head
Marc Fehling [Sat, 5 Jun 2021 03:30:45 +0000 (21:30 -0600)]
Make `hp::FEValuesBase` derive from `Subscriptor`.

3 years agoAdd changelog entry 11577/head
Rene Gassmoeller [Sun, 6 Jun 2021 21:12:44 +0000 (17:12 -0400)]
Add changelog entry

3 years agoMerge pull request #12392 from peterrum/cellwise_inserve_mass_factory
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

3 years agoAddress comments
Rene Gassmoeller [Sun, 6 Jun 2021 17:39:38 +0000 (13:39 -0400)]
Address comments

3 years agoStore particles in a vector
Rene Gassmoeller [Wed, 9 Dec 2020 23:59:29 +0000 (18:59 -0500)]
Store particles in a vector

3 years agoSimplify compute_point_to_point_communication_pattern() and compute_n_point_to_point_... 12393/head
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()

3 years agoRefactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMas... 12392/head
Peter Munch [Sat, 5 Jun 2021 15:07:04 +0000 (17:07 +0200)]
Refactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMassFactory

3 years agoMerge pull request #12377 from peterrum/part_simplify
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

3 years agoSimplify workflow of repartitioning 12377/head
Peter Munch [Tue, 1 Jun 2021 20:34:57 +0000 (22:34 +0200)]
Simplify workflow of repartitioning

Conflicts:
source/grid/tria_description.cc

3 years agoMerge pull request #12357 from peterrum/create_geometric_coarsening_sequence_new_const
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

3 years agoMerge pull request #12390 from peterrum/transform_from_q_points_to_basis
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

3 years agoMerge pull request #12389 from masterleinad/remove_deprecated_vector_tools
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

3 years agoMGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence(): make it... 12357/head
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

3 years agoCellwiseInverseMassMatrix::transform_from_q_points_to_basis: for degree = -1 and... 12390/head
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

3 years agoRemove deprecated VectorTools 12389/head
Daniel Arndt [Fri, 4 Jun 2021 14:58:24 +0000 (10:58 -0400)]
Remove deprecated VectorTools

3 years agoMerge pull request #12386 from masterleinad/remove_deprecated_fe_tools_l_to_h_numbering
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

3 years agoMerge pull request #12387 from peterrum/reduce_fix
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

3 years agoMerge pull request #12379 from simonsticko/fe_q_support_points_dim_1
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>.

3 years agoMerge pull request #12384 from masterleinad/remove_deprecated_cell_accessor_active
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()

3 years agoMerge pull request #12385 from masterleinad/remove_deprecated_vectorized_array_n_arra...
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

3 years agoFix ambiguous call in Utilities::MPI::all_reduce 12387/head
Peter Munch [Fri, 4 Jun 2021 10:47:30 +0000 (12:47 +0200)]
Fix ambiguous call in Utilities::MPI::all_reduce

3 years agoRemove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering 12386/head
Daniel Arndt [Thu, 3 Jun 2021 19:54:57 +0000 (15:54 -0400)]
Remove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering

3 years agoMerge pull request #12383 from peterrum/DEAL_II_DEPRECATED_EARLY_user
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

3 years agoRemove deprecated VectorizedArray::n_array_elements 12385/head
Daniel Arndt [Thu, 3 Jun 2021 16:18:18 +0000 (12:18 -0400)]
Remove deprecated VectorizedArray::n_array_elements

3 years agoRemove deprecated CellAccessor::active() 12384/head
Daniel Arndt [Thu, 3 Jun 2021 13:40:25 +0000 (09:40 -0400)]
Remove deprecated CellAccessor::active()

3 years agoAllow DEAL_II_DEPRECATED_EARLY in user code 12383/head
Peter Munch [Thu, 3 Jun 2021 11:19:44 +0000 (13:19 +0200)]
Allow DEAL_II_DEPRECATED_EARLY in user code

3 years agoAdd a 0-dimensional face support point on FE_Q<1>. 12379/head
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.

3 years agoMerge pull request #12382 from masterleinad/remove_deprecated_first_cell
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()

3 years agoReplace "#if defined(...)" by #ifdef(...) 12381/head
Daniel Arndt [Wed, 2 Jun 2021 21:44:11 +0000 (17:44 -0400)]
Replace "#if defined(...)" by #ifdef(...)

3 years agoRemove DataOut::first_cell() and DataOut::next_cell() 12382/head
Daniel Arndt [Wed, 2 Jun 2021 15:56:17 +0000 (11:56 -0400)]
Remove DataOut::first_cell() and DataOut::next_cell()

3 years agoRequire MPI for Trilinos
Daniel Arndt [Wed, 2 Jun 2021 15:52:53 +0000 (11:52 -0400)]
Require MPI for Trilinos

3 years agoMerge pull request #12376 from masterleinad/remove_deprecated_mg_transfer_build_matrices
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

3 years agoMerge pull request #12371 from peterrum/pdt_subcomm
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

3 years agoMerge pull request #12356 from peterrum/create_geometric_coarsening_sequence_new
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

3 years agoMerge pull request #12375 from peterrum/mg_transfer_global_coarsening_mesh_type
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

3 years agoRemove deprecated multigrid transfer build_matrices() functions 12376/head
Daniel Arndt [Tue, 1 Jun 2021 17:30:53 +0000 (13:30 -0400)]
Remove deprecated multigrid transfer build_matrices() functions

3 years agoTriangulationDescription::Utilities::create_description_from_triangulation(): allow... 12371/head
Peter Munch [Tue, 1 Jun 2021 08:27:04 +0000 (10:27 +0200)]
TriangulationDescription::Utilities::create_description_from_triangulation(): allow subcommunicator in pdt

3 years agoAdd new version of MGTransferGlobalCoarseningTools::create_geometric_coarsening_seque... 12356/head
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

3 years agoMerge pull request #12346 from peterrum/create_geometric_coarsening_sequence_trias
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

3 years agoMerge pull request #12373 from masterleinad/remove_deprecated_dof_tools_count_dofs_per
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_*()

3 years agoRemove MeshType from mg_transfer_global_coarsening.templates.h 12375/head
Peter Munch [Tue, 1 Jun 2021 16:41:08 +0000 (18:41 +0200)]
Remove MeshType from mg_transfer_global_coarsening.templates.h

3 years agoMerge pull request #12280 from peterrum/p_transfer_coarse_grid
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

3 years agoMerge pull request #12372 from simonsticko/face_interpolation_bernstein_2_fe_q
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.

3 years agoMerge pull request #12342 from marcfehling/doc-refinement
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()`.

3 years agoRemove deprecated versions of the DoFTools::count_dofs_per_*() 12373/head
Daniel Arndt [Tue, 1 Jun 2021 14:17:27 +0000 (10:17 -0400)]
Remove deprecated versions of the DoFTools::count_dofs_per_*()

3 years agoMerge pull request #12302 from nicola-giuliani/add-changes-and-test
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

3 years agoUpdate tests/grid/tria_clear_user_data.cc 12302/head
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>
3 years agoImplement face interpolation between FE_Bernstein and elements with support points. 12372/head
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.

3 years agoMerge pull request #12338 from masterleinad/remove_deprecated_dof_tools_extract_...
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

3 years agoMerge pull request #12348 from peterrum/partition_policies
Martin Kronbichler [Tue, 1 Jun 2021 07:30:27 +0000 (09:30 +0200)]
Merge pull request #12348 from peterrum/partition_policies

Introduce partitioning policies

3 years agoIntroduce partition policies 12348/head
Peter Munch [Sat, 29 May 2021 15:14:55 +0000 (17:14 +0200)]
Introduce partition policies

3 years agoMerge pull request #12368 from jppelteret/changelogs_02
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

3 years agoMerge pull request #12366 from marcfehling/fix-step-75
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.

3 years agoMerge pull request #12365 from peterrum/boost_point
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

3 years agoMerge pull request #12360 from simonsticko/face_interpolation_assert
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

3 years agoAdd changelog entry for step-74 12368/head
Jean-Paul Pelteret [Mon, 31 May 2021 18:50:49 +0000 (20:50 +0200)]
Add changelog entry for step-74

3 years agoBugfix step-75: Call `get_fe()` only on locally owned cells. 12366/head
Marc Fehling [Mon, 31 May 2021 17:59:25 +0000 (11:59 -0600)]
Bugfix step-75: Call `get_fe()` only on locally owned cells.

3 years agoFix creating of boost point 12365/head
Peter Munch [Mon, 31 May 2021 16:34:01 +0000 (18:34 +0200)]
Fix creating of boost point

3 years agoMerge pull request #12358 from tamiko/avoid_underlinkage
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

3 years agoMerge pull request #12363 from peterrum/rpe_race_condition
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

3 years agoMerge pull request #12331 from vachan-potluri/fe_dgq_legendre_shape_function_ordering_doc
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`

3 years agoMerge pull request #12361 from kronbichler/remove_changelog
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

3 years agoRemotePointEvaluation: fix race condition if called multiple times 12363/head
Peter Munch [Mon, 31 May 2021 11:35:55 +0000 (13:35 +0200)]
RemotePointEvaluation: fix race condition if called multiple times

3 years agoA better assert in FE_Q_Base::get_subface_interpolation_matrix 12360/head
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.

3 years agoRemove changelog entry about taskflow 12361/head
Martin Kronbichler [Mon, 31 May 2021 09:30:44 +0000 (11:30 +0200)]
Remove changelog entry about taskflow

3 years agoMerge pull request #12330 from peterrum/reduce
Martin Kronbichler [Mon, 31 May 2021 09:26:09 +0000 (11:26 +0200)]
Merge pull request #12330 from peterrum/reduce

Implement Utilities::MPI::reduce()

3 years agoMerge pull request #12353 from peterrum/rpe_rtree_level
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

3 years agoMerge pull request #12352 from peterrum/find_active_cell_around_point_outside
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

3 years agoMerge pull request #12312 from peterrum/create_description_from_triangulation_rep
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


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.