Skip to content
Snippets Groups Projects
Commit 5298876a authored by Christoph Rettinger's avatar Christoph Rettinger
Browse files

Merge branch 'new_field_utilities' into 'master'

New field utilities

See merge request walberla/walberla!61
parents 4e57552a 1e46802c
No related merge requests found
Showing
with 2338 additions and 1 deletion
...@@ -45,6 +45,7 @@ ...@@ -45,6 +45,7 @@
#include "allocation/all.h" #include "allocation/all.h"
#include "blockforest/all.h" #include "blockforest/all.h"
#include "communication/all.h" #include "communication/all.h"
#include "distributors/all.h"
#include "interpolators/all.h" #include "interpolators/all.h"
#include "iterators/all.h" #include "iterators/all.h"
#include "refinement/all.h" #include "refinement/all.h"
......
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file UniformPullReductionPackInfo.h
//! \ingroup field
//! \author Tobias Schruff <schruff@iww.rwth-aachen.de>
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "communication/UniformPackInfo.h"
#include "core/debug/Debug.h"
#include "field/GhostLayerField.h"
#include "stencil/Directions.h"
namespace walberla {
namespace field {
namespace communication {
/**
* Data packing/unpacking for ghost layer based communication of a single walberla::field::Field
*
* \ingroup comm
*
* template ReduceOperation is e.g. std::plus
*
* This pack info is used to apply a given reduce operation (e.g. +) to the values in the interior of a ghost layer field
* together with the values coming from the sender's ghost layer.
*/
template< template<typename> class ReduceOperation, typename GhostLayerField_T >
class UniformPullReductionPackInfo : public walberla::communication::UniformPackInfo
{
public:
typedef typename GhostLayerField_T::value_type T;
UniformPullReductionPackInfo( const BlockDataID & bdID ) : bdID_( bdID ), communicateAllGhostLayers_( true ),
numberOfGhostLayers_( 0 ) {}
UniformPullReductionPackInfo( const BlockDataID & bdID, const uint_t numberOfGhostLayers ) : bdID_( bdID ),
communicateAllGhostLayers_( false ), numberOfGhostLayers_( numberOfGhostLayers ) {}
virtual ~UniformPullReductionPackInfo() {}
bool constantDataExchange() const { return mpi::BufferSizeTrait<T>::constantSize; }
bool threadsafeReceiving() const { return true; }
void unpackData(IBlock * receiver, stencil::Direction dir, mpi::RecvBuffer & buffer);
void communicateLocal(const IBlock * sender, IBlock * receiver, stencil::Direction dir);
protected:
void packDataImpl(const IBlock * sender, stencil::Direction dir, mpi::SendBuffer & outBuffer) const;
uint_t numberOfGhostLayersToCommunicate( const GhostLayerField_T * const field ) const;
const BlockDataID bdID_;
bool communicateAllGhostLayers_;
uint_t numberOfGhostLayers_;
ReduceOperation<T> op_;
};
template< template<typename> class ReduceOperation, typename GhostLayerField_T >
void UniformPullReductionPackInfo<ReduceOperation, GhostLayerField_T>::unpackData( IBlock * receiver, stencil::Direction dir, mpi::RecvBuffer & buffer )
{
GhostLayerField_T * f = receiver->getData< GhostLayerField_T >( bdID_ );
WALBERLA_ASSERT_NOT_NULLPTR(f);
cell_idx_t nrOfGhostLayers = cell_idx_c( numberOfGhostLayersToCommunicate( f ) );
T buf( 0 );
for( auto i = f->beginSliceBeforeGhostLayer( dir, nrOfGhostLayers ); i != f->end(); ++i ) {
buffer >> buf;
*i = op_( *i, buf );
}
}
template< template<typename> class ReduceOperation, typename GhostLayerField_T>
void UniformPullReductionPackInfo<ReduceOperation, GhostLayerField_T>::communicateLocal( const IBlock * sender, IBlock * receiver, stencil::Direction dir )
{
const GhostLayerField_T * sf = sender ->getData< GhostLayerField_T >( bdID_ );
GhostLayerField_T * rf = receiver->getData< GhostLayerField_T >( bdID_ );
WALBERLA_ASSERT_EQUAL(sf->xSize(), rf->xSize());
WALBERLA_ASSERT_EQUAL(sf->ySize(), rf->ySize());
WALBERLA_ASSERT_EQUAL(sf->zSize(), rf->zSize());
uint_t nrOfGhostLayers = numberOfGhostLayersToCommunicate( sf );
auto srcIter = sf->beginGhostLayerOnly( nrOfGhostLayers, dir );
auto dstIter = rf->beginSliceBeforeGhostLayer( stencil::inverseDir[dir], cell_idx_c( nrOfGhostLayers ) );
while( srcIter != sf->end() ) {
*dstIter = op_( *srcIter, *dstIter );
++srcIter;
++dstIter;
}
WALBERLA_ASSERT(srcIter == sf->end() && dstIter == rf->end());
}
template< template<typename> class ReduceOperation, typename GhostLayerField_T>
void UniformPullReductionPackInfo<ReduceOperation, GhostLayerField_T>::packDataImpl( const IBlock * sender, stencil::Direction dir, mpi::SendBuffer & outBuffer ) const
{
const GhostLayerField_T * f = sender->getData< GhostLayerField_T >( bdID_ );
WALBERLA_ASSERT_NOT_NULLPTR(f);
uint_t nrOfGhostLayers = numberOfGhostLayersToCommunicate( f );
for( auto i = f->beginGhostLayerOnly( nrOfGhostLayers, dir ); i != f->end(); ++i )
outBuffer << *i;
}
template< template<typename> class ReduceOperation, typename GhostLayerField_T>
uint_t UniformPullReductionPackInfo<ReduceOperation, GhostLayerField_T>::numberOfGhostLayersToCommunicate( const GhostLayerField_T * const field ) const
{
if( communicateAllGhostLayers_ )
{
return field->nrOfGhostLayers();
}
else
{
WALBERLA_ASSERT_LESS_EQUAL( numberOfGhostLayers_, field->nrOfGhostLayers() );
return numberOfGhostLayers_;
}
}
} // namespace communication
} // namespace field
} // namespace walberla
...@@ -27,3 +27,4 @@ ...@@ -27,3 +27,4 @@
#include "MPIDatatypes.h" #include "MPIDatatypes.h"
#include "ReducePackInfo.h" #include "ReducePackInfo.h"
#include "UniformMPIDatatypeInfo.h" #include "UniformMPIDatatypeInfo.h"
#include "UniformPullReductionPackInfo.h"
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file DistributorCreators.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/DataTypes.h"
#include "core/Set.h"
#include "blockforest/BlockDataHandling.h"
#include "domain_decomposition/StructuredBlockStorage.h"
namespace walberla {
namespace field {
//**********************************************************************************************************************
/*! DistributorCreators
*
* \ingroup field
*
* Distributor_T: A distributor that has a constructor
* ( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block, const BaseField_T & baseField,
* const FlagField_T & flagField, const flag_t & evaluationMask )
* and distribution functions:
* template< typename ForwardIterator_T > inline void distribute( const Vector3<real_t> & position, ForwardIterator_T distributeValueBegin )
* template< typename ForwardIterator_T > inline void distribute( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T distributeValueBegin )
*
* See NearestNeighborDistributor for an example implementation.
*
* A distributor is aware of the flag field (FlagField_T) and distributes values only to cells flagged by a given mask.
*
* Distributors are used to spread a given value to the corresponding destination field.
* E.g. if a certain force has to be applied at some specific position onto the fluid, a distributor can be used
* to do so by distributing this force value (and conservation fo this force value is ensured) onto the force field.
*
*/
//**********************************************************************************************************************
template< typename Distributor_T, typename FlagField_T >
class DistributorHandling : public blockforest::AlwaysInitializeBlockDataHandling< Distributor_T >
{
public:
DistributorHandling( const weak_ptr<StructuredBlockStorage> & blockStorage,
const BlockDataID & distributionDestinationFieldID,
const ConstBlockDataID & flagFieldID,
const Set< FlagUID > & cellsToEvaluate ) :
blockStorage_( blockStorage ), distributionDestinationFieldID_( distributionDestinationFieldID ), flagFieldID_( flagFieldID ), cellsToEvaluate_( cellsToEvaluate )
{}
Distributor_T * initialize( IBlock * const block )
{
typedef typename Distributor_T::BaseField_T DistributionDestinationField_T;
typedef typename FlagField_T::flag_t flag_t;
DistributionDestinationField_T * distributionDestinationField = block->getData< DistributionDestinationField_T >( distributionDestinationFieldID_ );
const FlagField_T * flagField = block->getData< FlagField_T >( flagFieldID_ );
WALBERLA_ASSERT_NOT_NULLPTR( distributionDestinationField );
WALBERLA_ASSERT_NOT_NULLPTR( flagField );
const flag_t evaluationMask = flagField->getMask( cellsToEvaluate_ );
return new Distributor_T( blockStorage_, *block, *distributionDestinationField, *flagField, evaluationMask );
}
private:
weak_ptr<StructuredBlockStorage> blockStorage_;
BlockDataID distributionDestinationFieldID_;
ConstBlockDataID flagFieldID_;
Set< FlagUID > cellsToEvaluate_;
}; // class DistributorHandling
template< typename Distributor_T, typename FlagField_T >
inline BlockDataID addDistributor( const shared_ptr< StructuredBlockStorage > & blocks,
const BlockDataID & distributionDestinationFieldID,
const ConstBlockDataID & flagFieldID,
const Set< FlagUID > & cellsToEvaluate,
const std::string & identifier = std::string(),
const Set<SUID> & requiredSelectors = Set<SUID>::emptySet(),
const Set<SUID> & incompatibleSelectors = Set<SUID>::emptySet() )
{
return blocks->addBlockData( make_shared< DistributorHandling< Distributor_T, FlagField_T > >( blocks, distributionDestinationFieldID, flagFieldID, cellsToEvaluate ), identifier, requiredSelectors, incompatibleSelectors );
}
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file KernelDistributor.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/debug/Debug.h"
#include "core/math/Vector3.h"
#include "domain_decomposition/StructuredBlockStorage.h"
#include "field/interpolators/KernelFieldInterpolator.h"
#include "field/GhostLayerField.h"
#include <vector>
namespace walberla {
namespace field {
/*! Distributor for walberla::field::GhostLayerField with kernel strategy
*
* \ingroup field
*
* This distributor uses a smoothed dirac kernel function to distribute values to the field at the given position.
* The applied weights are given in the namespace field::kernelweights.
* Needs the full neighborhood of the containing cell, i.e. 27 cells.
* Never construct this distributor directly, but use the functionality from DistributorCreators.h instead.
*/
template< typename Field_T, typename FlagField_T >
class KernelDistributor
{
public:
static const uint_t F_SIZE = Field_T::F_SIZE;
typedef Field_T BaseField_T;
typedef typename FlagField_T::flag_t flag_t;
typedef KernelDistributor<Field_T,FlagField_T> OwnType;
KernelDistributor( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block,
BaseField_T & baseField, const FlagField_T & flagField,
const flag_t & evaluationMask )
: blockStorage_( blockStorage ), block_( block ), baseField_( baseField ), flagField_( flagField ), evaluationMask_( evaluationMask )
{
WALBERLA_ASSERT(baseField.nrOfGhostLayers() > uint_t(0), "field for kernel distribution needs at least one ghost layer");
}
inline bool operator==( const OwnType & other ){ return baseField_ == other.baseField_; }
template< typename ForwardIterator_T >
inline void distribute( const Vector3<real_t> & position, ForwardIterator_T distributeValueBegin )
{
distribute( position[0], position[1], position[2], distributeValueBegin );
}
template< typename ForwardIterator_T >
inline void distribute( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T distributeValueBegin )
{
WALBERLA_ASSERT(block_.getAABB().contains(x,y,z),
"Distribution position <" << x << ", " << y << ", " << z << "> is not contained inside the block of this distributor with AABB " << block_.getAABB() << " !");
WALBERLA_CHECK( !blockStorage_.expired() );
auto blockStorage = blockStorage_.lock();
WALBERLA_CHECK_NOT_NULLPTR(blockStorage);
Cell centerCell = blockStorage->getBlockLocalCell( block_, x, y, z );
const real_t dx = blockStorage->dx( blockStorage->getLevel( block_ ) );
const real_t dy = blockStorage->dy( blockStorage->getLevel( block_ ) );
const real_t dz = blockStorage->dz( blockStorage->getLevel( block_ ) );
const uint_t neighborhoodSize = cell_idx_t(1);
CellInterval cellNeighborhood( centerCell[0] - cell_idx_c(neighborhoodSize), centerCell[1] - cell_idx_c(neighborhoodSize), centerCell[2] - cell_idx_c(neighborhoodSize),
centerCell[0] + cell_idx_c(neighborhoodSize), centerCell[1] + cell_idx_c(neighborhoodSize), centerCell[2] + cell_idx_c(neighborhoodSize) );
const uint_t kernelSizeOneDirection = uint_t(2) * neighborhoodSize + uint_t(1);
std::vector<real_t> weights( kernelSizeOneDirection * kernelSizeOneDirection * kernelSizeOneDirection, real_t(0) );
uint_t counter = uint_t(0);
real_t sumOfWeights = real_t(0);
real_t sumOfWeightsUnavailable = real_t(0);
// get distribution weights and count available cells in surrounding cells
for( auto cellIt = cellNeighborhood.begin(); cellIt != cellNeighborhood.end(); ++cellIt )
{
Vector3<real_t> curCellCenter = blockStorage->getBlockLocalCellCenter( block_, *cellIt );
if( flagField_.isPartOfMaskSet( *cellIt, evaluationMask_ ) )
{
weights[counter] = kernelweights::kernelWeightFunction( x, y, z, curCellCenter[0], curCellCenter[1], curCellCenter[2], dx, dy, dz );
sumOfWeights += weights[counter];
}
else
{
weights[counter] = real_t(0);
sumOfWeightsUnavailable += kernelweights::kernelWeightFunction( x, y, z, curCellCenter[0], curCellCenter[1], curCellCenter[2], dx, dy, dz );
}
++counter;
}
// check if at least one cell was available, to prevent division by 0
if( sumOfWeights <= real_t(0) )
return;
// scale domain weights if some non-domain cells are in neighborhood
const real_t scalingFactor = real_t(1) + sumOfWeightsUnavailable / sumOfWeights;
// distribute the values to the neighboring domain cells with the corresponding (scaled) weighting
counter = uint_t(0);
for( auto cellIt = cellNeighborhood.begin(); cellIt != cellNeighborhood.end(); ++cellIt )
{
if ( weights[counter] > real_t(0) )
{
addWeightedCellValue( distributeValueBegin, *cellIt, scalingFactor * weights[counter] );
}
++counter;
}
}
private:
template< typename ForwardIterator_T >
void addWeightedCellValue( ForwardIterator_T distributeValueBegin, const Cell & curCell, const real_t & weighting )
{
for( uint_t f = uint_t(0); f < F_SIZE; ++f )
{
baseField_( curCell, f) += weighting * (*distributeValueBegin);
++distributeValueBegin;
}
}
weak_ptr<StructuredBlockStorage> blockStorage_;
const IBlock & block_;
BaseField_T & baseField_;
const FlagField_T & flagField_;
flag_t evaluationMask_;
};
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file NearestNeighborDistributor.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/math/Vector3.h"
#include "domain_decomposition/StructuredBlockStorage.h"
#include "field/GhostLayerField.h"
#include <numeric>
#include <vector>
namespace walberla {
namespace field {
/*! Distributor for walberla::field::Field with nearest neighbor strategy
*
* \ingroup field
*
* This distributor distributes the given value to the nearest cell, flagged in the evaluation mask, of the given position.
* This is usually the cell that contains the distribution position.
* If this cell is a cell that is not within the evaluation mask, the direct neighborhood (8 cells) will be searched for an available cell.
* Never construct this distributor directly, but use the functionality from DistributorCreators.h instead.
*/
template< typename Field_T, typename FlagField_T >
class NearestNeighborDistributor
{
public:
static const uint_t F_SIZE = Field_T::F_SIZE;
typedef Field_T BaseField_T;
typedef typename FlagField_T::flag_t flag_t;
typedef NearestNeighborDistributor<Field_T,FlagField_T> OwnType;
NearestNeighborDistributor( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block,
BaseField_T & baseField, const FlagField_T & flagField,
const flag_t & evaluationMask )
: blockStorage_( blockStorage ), block_( block ), baseField_( baseField ), flagField_( flagField ), evaluationMask_( evaluationMask )
{}
inline bool operator==( const OwnType & other ){ return baseField_ == other.baseField_; }
template< typename ForwardIterator_T >
inline void distribute( const Vector3<real_t> & position, ForwardIterator_T distributeValueBegin )
{
distribute( position[0], position[1], position[2], distributeValueBegin );
}
template< typename ForwardIterator_T >
inline void distribute( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T distributeValueBegin )
{
WALBERLA_ASSERT(block_.getAABB().contains(x,y,z),
"Distribution position <" << x << ", " << y << ", " << z << "> is not contained inside the block of this distributor with AABB " << block_.getAABB() << " !");
WALBERLA_CHECK( !blockStorage_.expired() );
auto blockStorage = blockStorage_.lock();
WALBERLA_CHECK_NOT_NULLPTR(blockStorage);
Cell nearestCell = blockStorage->getBlockLocalCell( block_, x, y, z );
if( flagField_.isPartOfMaskSet( nearestCell, evaluationMask_ ) )
{
for( uint_t f = uint_t(0); f < F_SIZE; ++f )
{
baseField_( nearestCell, f) += *distributeValueBegin;
++distributeValueBegin;
}
return;
}
else
{
// look for available cell in direct neighborhood
CellInterval fieldXYZSize = baseField_.xyzSize();
Vector3<real_t> nearestCellCenter = blockStorage->getBlockLocalCellCenter( block_, nearestCell );
const cell_idx_t xNeighbor = cell_idx_c( floor( x - nearestCellCenter[0] ) );
const cell_idx_t yNeighbor = cell_idx_c( floor( y - nearestCellCenter[1] ) );
const cell_idx_t zNeighbor = cell_idx_c( floor( z - nearestCellCenter[2] ) );
const cell_idx_t xMin = nearestCell.x() + xNeighbor;
const cell_idx_t yMin = nearestCell.y() + yNeighbor;
const cell_idx_t zMin = nearestCell.z() + zNeighbor;
for( cell_idx_t zC = zMin; zC <= zMin + cell_idx_t(1); ++zC)
{
for( cell_idx_t yC = yMin; yC <= yMin + cell_idx_t(1); ++yC)
{
for( cell_idx_t xC = xMin; xC <= xMin + cell_idx_t(1); ++xC)
{
Cell curCell(xC,yC,zC);
if( fieldXYZSize.contains(curCell) )
{
if (flagField_.isPartOfMaskSet(curCell, evaluationMask_))
{
for (uint_t f = uint_t(0); f < F_SIZE; ++f)
{
baseField_(curCell, f) += *distributeValueBegin;
++distributeValueBegin;
}
return;
}
}
}
}
}
}
}
private:
weak_ptr<StructuredBlockStorage> blockStorage_;
const IBlock & block_;
BaseField_T & baseField_;
const FlagField_T & flagField_;
flag_t evaluationMask_;
};
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file all.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "DistributorCreators.h"
#include "KernelDistributor.h"
#include "NearestNeighborDistributor.h"
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file FieldInterpolatorCreators.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/DataTypes.h"
#include "core/Set.h"
#include "blockforest/BlockDataHandling.h"
#include "domain_decomposition/StructuredBlockStorage.h"
namespace walberla {
namespace field {
//**********************************************************************************************************************
/*! FieldInterpolatorCreators
*
* \ingroup field
*
* Interpolator_T: A field interpolator that has a constructor
* ( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block, const BaseField_T & baseField,
* const FlagField_T & flagField, const flag_t & evaluationMask )
* and getter functions:
* template< typename ForwardIterator_T > inline void get( const Vector3<real_t> & position, ForwardIterator_T interpolationResultBegin )
* template< typename ForwardIterator_T > inline void get( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T interpolationResultBegin )
*
* See TrilinearFieldInterpolator for an example implementation.
*
* A field interpolator is aware of the flag field (FlagField_T) and uses only values that contain flags from a given mask.
*
* Field Interpolators can be used to sample the underlying field at certain positions.
* E.g. the fluid velocity can be interpolated to a desired global position from a velocity field.
*
*/
//**********************************************************************************************************************
template< typename Interpolator_T, typename FlagField_T >
class InterpolatorHandling : public blockforest::AlwaysInitializeBlockDataHandling< Interpolator_T >
{
public:
InterpolatorHandling( const weak_ptr<StructuredBlockStorage> & blockStorage,
const ConstBlockDataID & interpolatedFieldID,
const ConstBlockDataID & flagFieldID,
const Set< FlagUID > & cellsToEvaluate ) :
blockStorage_( blockStorage ), interpolatedFieldID_( interpolatedFieldID ), flagFieldID_( flagFieldID ), cellsToEvaluate_( cellsToEvaluate )
{}
Interpolator_T * initialize( IBlock * const block )
{
typedef typename Interpolator_T::BaseField_T InterpolatedField_T;
typedef typename FlagField_T::flag_t flag_t;
const InterpolatedField_T * interpolatedField = block->getData< InterpolatedField_T >( interpolatedFieldID_ );
const FlagField_T * flagField = block->getData< FlagField_T >( flagFieldID_ );
WALBERLA_ASSERT_NOT_NULLPTR( interpolatedField );
WALBERLA_ASSERT_NOT_NULLPTR( flagField );
const flag_t evaluationMask = flagField->getMask( cellsToEvaluate_ );
return new Interpolator_T( blockStorage_, *block, *interpolatedField, *flagField, evaluationMask );
}
private:
weak_ptr<StructuredBlockStorage> blockStorage_;
ConstBlockDataID interpolatedFieldID_;
ConstBlockDataID flagFieldID_;
Set< FlagUID > cellsToEvaluate_;
}; // class InterpolatorHandling
template< typename Interpolator_T, typename FlagField_T >
inline BlockDataID addFieldInterpolator( const shared_ptr< StructuredBlockStorage > & blocks,
const ConstBlockDataID & interpolatedFieldID,
const ConstBlockDataID & flagFieldID,
const Set< FlagUID > & cellsToEvaluate,
const std::string & identifier = std::string(),
const Set<SUID> & requiredSelectors = Set<SUID>::emptySet(),
const Set<SUID> & incompatibleSelectors = Set<SUID>::emptySet() )
{
return blocks->addBlockData( make_shared< InterpolatorHandling< Interpolator_T, FlagField_T > >( blocks, interpolatedFieldID, flagFieldID, cellsToEvaluate ), identifier, requiredSelectors, incompatibleSelectors );
}
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file KernelFieldInterpolator.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/debug/Debug.h"
#include "core/math/Vector3.h"
#include "domain_decomposition/StructuredBlockStorage.h"
#include "field/FlagField.h"
#include "stencil/D3Q27.h"
#include <numeric>
namespace walberla {
namespace field {
namespace kernelweights
{
// corresponds to the smoothed dirac delta function from Roma et al - An Adaptive Version of the Immersed Boundary Method
// f(r) != 0 for abs(r) < 1.5 -> requires three neighborhood cells
real_t smoothedDeltaFunction( const real_t & r )
{
real_t rAbs = std::fabs(r);
if( rAbs <= real_t(0.5) )
{
return (real_t(1) + std::sqrt( - real_t(3) * r * r + real_t(1) ) ) * (real_t(1) / real_t(3));
} else if ( rAbs < real_t(1.5) )
{
return (real_t(5) - real_t(3) * rAbs - std::sqrt( - real_t(3) * ( real_t(1) - rAbs ) * ( real_t(1) - rAbs ) + real_t(1) ) ) * ( real_t(1) / real_t(6) );
} else
{
return real_t(0);
}
}
// X: Lagrangian position, x: Eulerian position (usually cell center), global coordinates
// dx, dy, dz: mesh spacing
real_t kernelWeightFunction( const real_t & X, const real_t & Y, const real_t & Z,
const real_t & x, const real_t & y, const real_t & z,
const real_t & dx = real_t(1), const real_t & dy = real_t(1), const real_t & dz = real_t(1) )
{
return smoothedDeltaFunction( ( X - x ) / dx ) * smoothedDeltaFunction( ( Y - y ) / dy ) * smoothedDeltaFunction( ( Z - z ) / dz );
}
// X: Lagrangian position, x: Eulerian position (usually cell center), global coordinates
// dx, dy, dz: mesh spacing
real_t kernelWeightFunction( const Vector3<real_t> & X, const Vector3<real_t> & x,
const real_t & dx = real_t(1), const real_t & dy = real_t(1), const real_t & dz = real_t(1) )
{
return smoothedDeltaFunction( ( X[0] - x[0] ) / dx ) * smoothedDeltaFunction( ( X[1] - x[1] ) / dy ) * smoothedDeltaFunction( ( X[2] - x[2] ) / dz );
}
} // namespace kernelweights
/*! Interpolator for walberla::field::GhostLayerField with kernel strategy
*
* \ingroup field
*
* This interpolator uses a smoothed dirac kernel function to interpolate values.
* The applied weights are given in the namespace field::kernelweights.
* Needs the full neighborhood of the containing cell, i.e. 27 cells.
* Never construct this interpolator directly, but use the functionality from the FieldInterpolatorCreator.h instead.
*/
template< typename Field_T, typename FlagField_T >
class KernelFieldInterpolator
{
public:
static const uint_t F_SIZE = Field_T::F_SIZE;
typedef Field_T BaseField_T;
typedef typename FlagField_T::flag_t flag_t;
typedef KernelFieldInterpolator<Field_T,FlagField_T> OwnType;
KernelFieldInterpolator( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block,
const BaseField_T & baseField, const FlagField_T & flagField,
const flag_t & evaluationMask )
: blockStorage_( blockStorage ), block_( block ), baseField_( baseField ), flagField_( flagField ), evaluationMask_( evaluationMask )
{
WALBERLA_ASSERT(baseField.nrOfGhostLayers() > uint_t(0), "field for kernel interpolation needs at least one ghost layer");
}
inline bool operator==( const OwnType & other ){ return baseField_ == other.baseField_; }
template< typename ForwardIterator_T >
inline void get( const Vector3<real_t> & position, ForwardIterator_T interpolationResultBegin )
{
get( position[0], position[1], position[2], interpolationResultBegin );
}
template< typename ForwardIterator_T >
inline void get( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T interpolationResultBegin )
{
WALBERLA_ASSERT(block_.getAABB().contains(x,y,z),
"Interpolation position <" << x << ", " << y << ", " << z << "> is not contained inside the block of this interpolator with AABB " << block_.getAABB() << " !");
WALBERLA_CHECK( !blockStorage_.expired() );
auto blockStorage = blockStorage_.lock();
WALBERLA_CHECK_NOT_NULLPTR(blockStorage);
Cell centerCell = blockStorage->getBlockLocalCell( block_, x, y, z );
const real_t dx = blockStorage->dx( blockStorage->getLevel( block_ ) );
const real_t dy = blockStorage->dy( blockStorage->getLevel( block_ ) );
const real_t dz = blockStorage->dz( blockStorage->getLevel( block_ ) );
const uint_t neighborhoodSize = uint_t(1);
CellInterval cellNeighborhood( centerCell[0] - cell_idx_c(neighborhoodSize), centerCell[1] - cell_idx_c(neighborhoodSize), centerCell[2] - cell_idx_c(neighborhoodSize),
centerCell[0] + cell_idx_c(neighborhoodSize), centerCell[1] + cell_idx_c(neighborhoodSize), centerCell[2] + cell_idx_c(neighborhoodSize) );
const uint_t kernelSizeOneDirection = uint_t(2) * neighborhoodSize + uint_t(1);
// store the calculated weighting factors of the available cells, i.e. cells flagged by the evaluation mask
std::vector<real_t> weights( kernelSizeOneDirection * kernelSizeOneDirection * kernelSizeOneDirection, real_t(0) );
// store the calculated weighting factors of the UNavailable cells, i.e. cells not included in the evaluation mask
std::vector<real_t> weightsUnavailable( kernelSizeOneDirection * kernelSizeOneDirection * kernelSizeOneDirection, real_t(0) );
cell_idx_t cellIdx0x = cellNeighborhood.xMin();
cell_idx_t cellIdx0y = cellNeighborhood.yMin();
cell_idx_t cellIdx0z = cellNeighborhood.zMin();
uint_t nx = kernelSizeOneDirection;
uint_t nxy = kernelSizeOneDirection * kernelSizeOneDirection;
Vector3<real_t> cellCenter0 = blockStorage->getBlockLocalCellCenter( block_, Cell(cellIdx0x, cellIdx0y, cellIdx0z) ); // = cell in neighborhood with smallest x-, y-, and z-indices
// calculate kernel weights of all cells in neighborhood
for( uint_t k = uint_t(0); k < kernelSizeOneDirection; ++k)
{
for( uint_t j = uint_t(0); j < kernelSizeOneDirection; ++j)
{
for( uint_t i = uint_t(0); i < kernelSizeOneDirection; ++i)
{
Vector3<real_t> curCellCenter( cellCenter0[0] + real_c(i) * dx, cellCenter0[1] + real_c(j) * dy, cellCenter0[2] + real_c(k) * dz);
if( flagField_.isPartOfMaskSet( cellIdx0x + cell_idx_c(i), cellIdx0y + cell_idx_c(j), cellIdx0z + cell_idx_c(k), evaluationMask_ ) )
{
weights[k*nxy+j*nx+i] = kernelweights::kernelWeightFunction( x, y, z, curCellCenter[0], curCellCenter[1], curCellCenter[2], dx, dy, dz );
}
else
{
weightsUnavailable[k*nxy+j*nx+i] = kernelweights::kernelWeightFunction( x, y, z, curCellCenter[0], curCellCenter[1], curCellCenter[2], dx, dy, dz );
}
}
}
}
/*
// zero entries in weights array (and non-zero entries in weightsUnavailable) indicate non-fluid nodes
// weight correction to incorporate extrapolation for kernel interpolation, center element can not be redistributed
// without this part, the kernel interpolator can not extrapolate values
// this is based on experimental findings by the author and general correctness is not ensured, thus it is commented out
for( auto stenIt = stencil::D3Q27::beginNoCenter(); stenIt != stencil::D3Q27::end(); ++stenIt )
{
int cx = stenIt.cx();
int cy = stenIt.cy();
int cz = stenIt.cz();
int i = cx + 1;
int j = cy + 1;
int k = cz + 1;
if( weightsUnavailable[k*nxy+j*nx+i] > real_t(0) )
{
// check if we can distribute the non-fluid weight to nearby fluid weights that lie in one line inside the neighborhood
// it should generally not matter in which direction it is distributed
// check x direction
if( weights[k*nxy+j*nx+i-cx] > real_t(0) && weights[k*nxy+j*nx+i-2*cx] > real_t(0) )
{
weights[k*nxy+j*nx+i-cx] += real_t(2)*weightsUnavailable[k*nxy+j*nx+i];
weights[k*nxy+j*nx+i-2*cx] -= weightsUnavailable[k*nxy+j*nx+i];
weightsUnavailable[k*nxy+j*nx+i] = real_t(0);
continue;
}
// check y direction
if( weights[k*nxy+(j-cy)*nx+i] > real_t(0) && weights[k*nxy+(j-2*cy)*nx+i] > real_t(0) )
{
weights[k*nxy+(j-cy)*nx+i] += real_t(2)*weightsUnavailable[k*nxy+j*nx+i];
weights[k*nxy+(j-2*cy)*nx+i] -= weightsUnavailable[k*nxy+j*nx+i];
weightsUnavailable[k*nxy+j*nx+i] = real_t(0);
continue;
}
// check z direction
if( weights[(k-cz)*nxy+j*nx+i] > real_t(0) && weights[(k-2*cz)*nxy+j*nx+i] > real_t(0) )
{
weights[(k-cz)*nxy+j*nx+i] += real_t(2)*weightsUnavailable[k*nxy+j*nx+i];
weights[(k-2*cz)*nxy+j*nx+i] -= weightsUnavailable[k*nxy+j*nx+i];
weightsUnavailable[k*nxy+j*nx+i] = real_t(0);
continue;
}
}
}
*/
// scale available weights by the total amount of unavailable weights such that afterwards sum over all weights is 1
const real_t sumOfWeightsUnavailable = std::accumulate(weightsUnavailable.begin(), weightsUnavailable.end(), real_t(0) );
const real_t sumOfWeights = std::accumulate(weights.begin(), weights.end(), real_t(0) );
// check if at least one cell was available, to prevent division by 0
if( sumOfWeights <= real_t(0) )
return;
const real_t scalingFactor = real_t(1) + sumOfWeightsUnavailable / sumOfWeights;
for( auto weightIt = weights.begin(); weightIt != weights.end(); ++weightIt )
{
*weightIt *= scalingFactor;
}
// interpolate value to interpolation position using the previously calculated weights
// values to not be included have a weight of 0
for( uint_t k = uint_t(0); k < kernelSizeOneDirection; ++k)
{
for( uint_t j = uint_t(0); j < kernelSizeOneDirection; ++j)
{
for( uint_t i = uint_t(0); i < kernelSizeOneDirection; ++i)
{
if ( weights[k*nxy+j*nx+i] > real_t(0) )
{
Cell curCell( cellIdx0x + cell_idx_c(i), cellIdx0y + cell_idx_c(j), cellIdx0z + cell_idx_c(k) );
addWeightedCellValue( interpolationResultBegin, curCell, weights[k*nxy+j*nx+i] );
}
}
}
}
}
private:
template< typename ForwardIterator_T >
void addWeightedCellValue( ForwardIterator_T interpolationResultBegin, const Cell & curCell, const real_t & weighting )
{
for( uint_t f = uint_t(0); f < F_SIZE; ++f )
{
WALBERLA_ASSERT( !math::isnan(baseField_( curCell, f)), "NaN found in component " << f << " when interpolating from cell " << curCell );
*interpolationResultBegin += weighting * baseField_( curCell, f);
++interpolationResultBegin;
}
}
weak_ptr<StructuredBlockStorage> blockStorage_;
const IBlock & block_;
const BaseField_T & baseField_;
const FlagField_T & flagField_;
flag_t evaluationMask_;
};
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file NearestNeighborFieldInterpolator.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/debug/Debug.h"
#include "domain_decomposition/StructuredBlockStorage.h"
#include "field/FlagField.h"
namespace walberla {
namespace field {
/*! Interpolator for walberla::field::Field with nearest neighbor strategy
*
* \ingroup field
*
* This interpolator obtains the value from the nearest cell, flagged in the evaluation mask, of the interpolation position.
* This is usually the cell that contains the interpolation position.
* If this cell is a cell that is not within the evaluation mask, the direct neighborhood (8 cells) will be searched for an available cell.
* Never construct this interpolator directly, but use the functionality from FieldInterpolatorCreators.h instead.
*/
template< typename Field_T, typename FlagField_T >
class NearestNeighborFieldInterpolator
{
public:
static const uint_t F_SIZE = Field_T::F_SIZE;
typedef Field_T BaseField_T;
typedef typename FlagField_T::flag_t flag_t;
typedef NearestNeighborFieldInterpolator<Field_T,FlagField_T> OwnType;
NearestNeighborFieldInterpolator( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block,
const BaseField_T & baseField, const FlagField_T & flagField,
const flag_t & evaluationMask )
: blockStorage_( blockStorage ), block_( block ), baseField_( baseField ), flagField_( flagField ), evaluationMask_( evaluationMask )
{}
inline bool operator==( const OwnType & other ){ return baseField_ == other.baseField_; }
template< typename ForwardIterator_T >
inline void get( const Vector3<real_t> & position, ForwardIterator_T interpolationResultBegin )
{
get( position[0], position[1], position[2], interpolationResultBegin );
}
template< typename ForwardIterator_T >
inline void get( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T interpolationResultBegin )
{
WALBERLA_ASSERT(block_.getAABB().contains(x,y,z),
"Interpolation position <" << x << ", " << y << ", " << z << "> is not contained inside the block of this interpolator with AABB " << block_.getAABB() << " !");
WALBERLA_CHECK( !blockStorage_.expired() );
auto blockStorage = blockStorage_.lock();
WALBERLA_CHECK_NOT_NULLPTR(blockStorage);
Cell nearestCell = blockStorage->getBlockLocalCell( block_, x, y, z );
if( flagField_.isPartOfMaskSet( nearestCell, evaluationMask_ ) )
{
for( uint_t f = uint_t(0); f < F_SIZE; ++f )
{
WALBERLA_ASSERT( !math::isnan( baseField_( nearestCell, f) ), "NaN found in component " << f << " when interpolating from cell " << nearestCell );
*interpolationResultBegin = baseField_( nearestCell, f);
++interpolationResultBegin;
}
}
else
{
// look for available cell in direct neighborhood
CellInterval fieldXYZSize = baseField_.xyzSize();
Vector3<real_t> nearestCellCenter = blockStorage->getBlockLocalCellCenter( block_, nearestCell );
const cell_idx_t xNeighbor = cell_idx_c( floor( x - nearestCellCenter[0] ) );
const cell_idx_t yNeighbor = cell_idx_c( floor( y - nearestCellCenter[1] ) );
const cell_idx_t zNeighbor = cell_idx_c( floor( z - nearestCellCenter[2] ) );
const cell_idx_t xMin = nearestCell.x() + xNeighbor;
const cell_idx_t yMin = nearestCell.y() + yNeighbor;
const cell_idx_t zMin = nearestCell.z() + zNeighbor;
for( cell_idx_t zC = zMin; zC <= zMin + cell_idx_t(1); ++zC)
{
for( cell_idx_t yC = yMin; yC <= yMin + cell_idx_t(1); ++yC)
{
for( cell_idx_t xC = xMin; xC <= xMin + cell_idx_t(1); ++xC)
{
Cell curCell(xC,yC,zC);
if( fieldXYZSize.contains(curCell) )
{
if (flagField_.isPartOfMaskSet(curCell, evaluationMask_))
{
for (uint_t f = uint_t(0); f < F_SIZE; ++f)
{
WALBERLA_ASSERT(!math::isnan(baseField_(curCell, f)),
"NaN found in component " << f << " when interpolating from cell "
<< curCell);
*interpolationResultBegin = baseField_(curCell, f);
++interpolationResultBegin;
}
break;
}
}
}
}
}
}
}
private:
weak_ptr<StructuredBlockStorage> blockStorage_;
const IBlock & block_;
const BaseField_T & baseField_;
const FlagField_T & flagField_;
flag_t evaluationMask_;
};
} // namespace field
} // namespace walberla
//======================================================================================================================
//
// This file is part of waLBerla. waLBerla is free software: you can
// redistribute it and/or modify it under the terms of the GNU General Public
// License as published by the Free Software Foundation, either version 3 of
// the License, or (at your option) any later version.
//
// waLBerla is distributed in the hope that it will be useful, but WITHOUT
// ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
// FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
// for more details.
//
// You should have received a copy of the GNU General Public License along
// with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>.
//
//! \file TrilinearFieldInterpolator.h
//! \ingroup field
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//
//======================================================================================================================
#pragma once
#include "core/debug/Debug.h"
#include "domain_decomposition/StructuredBlockStorage.h"
#include "field/FlagField.h"
namespace walberla {
namespace field {
/*! Interpolator for walberla::field::GhostLayerField with trilinear strategy
*
* \ingroup field
*
* This interpolator uses trilinear interpolation to obtain the interpolated value from the interpolation position.
* If at least one of the cells, that are required for trilinear interpolation, i.e. the 8 closest cells,
* is not contained in the evaluation mask, the nearest-neighbor interpolation (see NearestNeighborFieldInterpolator.h)
* will be used instead.
* Never construct this interpolator directly, but use the functionality from FieldInterpolatorCreators.h instead.
*/
template< typename Field_T, typename FlagField_T >
class TrilinearFieldInterpolator
{
public:
static const uint_t F_SIZE = Field_T::F_SIZE;
typedef Field_T BaseField_T;
typedef typename FlagField_T::flag_t flag_t;
typedef TrilinearFieldInterpolator<Field_T,FlagField_T> OwnType;
TrilinearFieldInterpolator( const weak_ptr<StructuredBlockStorage> & blockStorage, const IBlock & block,
const BaseField_T & baseField, const FlagField_T & flagField,
const flag_t & evaluationMask )
: blockStorage_( blockStorage ), block_( block ), baseField_( baseField ), flagField_( flagField ), evaluationMask_( evaluationMask ),
nearestNeighborInterpolator_( blockStorage, block, baseField, flagField, evaluationMask )
{
WALBERLA_ASSERT(baseField.nrOfGhostLayers() > uint_t(0), "field for trilinear interpolation needs at least one ghost layer");
}
inline bool operator==( const OwnType & other ){ return baseField_ == other.baseField_; }
template< typename ForwardIterator_T >
inline void get( const Vector3<real_t> & position, ForwardIterator_T interpolationResultBegin )
{
get( position[0], position[1], position[2], interpolationResultBegin );
}
template< typename ForwardIterator_T >
inline void get( const real_t & x, const real_t & y, const real_t & z, ForwardIterator_T interpolationResultBegin )
{
WALBERLA_ASSERT(block_.getAABB().contains(x,y,z),
"Interpolation position <" << x << ", " << y << ", " << z << "> is not contained inside the block of this interpolator with AABB " << block_.getAABB() << " !");
WALBERLA_CHECK( !blockStorage_.expired() );
auto blockStorage = blockStorage_.lock();
WALBERLA_CHECK_NOT_NULLPTR(blockStorage);
const real_t dx = blockStorage->dx( blockStorage->getLevel( block_ ) );
const real_t dy = blockStorage->dy( blockStorage->getLevel( block_ ) );
const real_t dz = blockStorage->dz( blockStorage->getLevel( block_ ) );
Cell containingCell = blockStorage->getBlockLocalCell( block_, x, y, z );
Vector3<real_t> containingCellCenter = blockStorage->getBlockLocalCellCenter( block_, containingCell );
const cell_idx_t xNeighbor1 = cell_idx_c( floor( x - containingCellCenter[0] ) );
const cell_idx_t xNeighbor2 = xNeighbor1 + cell_idx_t(1);
const cell_idx_t yNeighbor1 = cell_idx_c( floor( y - containingCellCenter[1] ) );
const cell_idx_t yNeighbor2 = yNeighbor1 + cell_idx_t(1);
const cell_idx_t zNeighbor1 = cell_idx_c( floor( z - containingCellCenter[2] ) );
const cell_idx_t zNeighbor2 = zNeighbor1 + cell_idx_t(1);
// define the 8 nearest cells required for the trilienar interpolation
// the cell 'ccc' is the one with the smallest x-, y-, and z-indices
Cell ccc( containingCell.x() + xNeighbor1, containingCell.y() + yNeighbor1, containingCell.z() + zNeighbor1 );
Cell hcc( containingCell.x() + xNeighbor2, containingCell.y() + yNeighbor1, containingCell.z() + zNeighbor1 );
Cell chc( containingCell.x() + xNeighbor1, containingCell.y() + yNeighbor2, containingCell.z() + zNeighbor1 );
Cell hhc( containingCell.x() + xNeighbor2, containingCell.y() + yNeighbor2, containingCell.z() + zNeighbor1 );
Cell cch( containingCell.x() + xNeighbor1, containingCell.y() + yNeighbor1, containingCell.z() + zNeighbor2 );
Cell hch( containingCell.x() + xNeighbor2, containingCell.y() + yNeighbor1, containingCell.z() + zNeighbor2 );
Cell chh( containingCell.x() + xNeighbor1, containingCell.y() + yNeighbor2, containingCell.z() + zNeighbor2 );
Cell hhh( containingCell.x() + xNeighbor2, containingCell.y() + yNeighbor2, containingCell.z() + zNeighbor2 );
// check if all neighboring cells are domain cells
if( flagField_.isPartOfMaskSet( ccc, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( hcc, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( chc, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( hhc, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( cch, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( hch, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( chh, evaluationMask_ ) &&
flagField_.isPartOfMaskSet( hhh, evaluationMask_ ) )
{
// trilinear interpolation can be applied
const real_t inv_totalVolume = real_t(1) / ( dx * dy * dz );
Vector3<real_t> cccCellCenter = blockStorage->getBlockLocalCellCenter( block_, ccc );
// weighting = volume of opposing volume element / total volume
real_t weighting(0.0);
// x: (c)---dxc--(X)--------------dxh-------------(h)
const real_t dxc = x - cccCellCenter[0];
const real_t dxh = cccCellCenter[0] + dx - x;
const real_t dyc = y - cccCellCenter[1];
const real_t dyh = cccCellCenter[1] + dy - y;
const real_t dzc = z - cccCellCenter[2];
const real_t dzh = cccCellCenter[2] + dz - z;
weighting = dxh * dyh * dzh * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, ccc, weighting );
weighting = dxc * dyh * dzh * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, hcc, weighting );
weighting = dxh * dyc * dzh * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, chc, weighting );
weighting = dxc * dyc * dzh * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, hhc, weighting );
weighting = dxh * dyh * dzc * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, cch, weighting );
weighting = dxc * dyh * dzc * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, hch, weighting );
weighting = dxh * dyc * dzc * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, chh, weighting );
weighting = dxc * dyc * dzc * inv_totalVolume;
addWeightedCellValue( interpolationResultBegin, hhh, weighting );
}
else
{
// revert to nearest neighbor interpolation
nearestNeighborInterpolator_.get( x, y, z, interpolationResultBegin );
}
}
private:
template< typename ForwardIterator_T >
void addWeightedCellValue( ForwardIterator_T interpolationResultBegin, const Cell & curCell, const real_t & weighting )
{
for( uint_t f = uint_t(0); f < F_SIZE; ++f )
{
WALBERLA_ASSERT( !math::isnan(baseField_( curCell, f)), "NaN found in component " << f << " when interpolating from cell " << curCell );
*interpolationResultBegin += weighting * baseField_( curCell, f);
++interpolationResultBegin;
}
}
weak_ptr<StructuredBlockStorage> blockStorage_;
const IBlock & block_;
const BaseField_T & baseField_;
const FlagField_T & flagField_;
flag_t evaluationMask_;
NearestNeighborFieldInterpolator<Field_T,FlagField_T> nearestNeighborInterpolator_;
};
} // namespace field
} // namespace walberla
...@@ -24,3 +24,8 @@ ...@@ -24,3 +24,8 @@
#include "NearestNeighborInterpolator.h" #include "NearestNeighborInterpolator.h"
#include "TrilinearInterpolator.h" #include "TrilinearInterpolator.h"
#include "FieldInterpolatorCreators.h"
#include "KernelFieldInterpolator.h"
#include "NearestNeighborFieldInterpolator.h"
#include "TrilinearFieldInterpolator.h"
...@@ -10,6 +10,9 @@ waLBerla_execute_test( NAME AccuracyEvaluationTest4 COMMAND $<TARGET_FILE:Accura ...@@ -10,6 +10,9 @@ waLBerla_execute_test( NAME AccuracyEvaluationTest4 COMMAND $<TARGET_FILE:Accura
waLBerla_compile_test( FILES communication/FieldPackInfoTest.cpp DEPENDS blockforest ) waLBerla_compile_test( FILES communication/FieldPackInfoTest.cpp DEPENDS blockforest )
waLBerla_execute_test( NAME FieldPackInfoTest ) waLBerla_execute_test( NAME FieldPackInfoTest )
waLBerla_compile_test( FILES distributors/DistributionTest.cpp)
waLBerla_execute_test( NAME DistributionTest )
waLBerla_compile_test( FILES FieldTest.cpp ) waLBerla_compile_test( FILES FieldTest.cpp )
waLBerla_execute_test( NAME FieldTest ) waLBerla_execute_test( NAME FieldTest )
...@@ -25,6 +28,9 @@ waLBerla_execute_test( NAME FlagFieldTest ) ...@@ -25,6 +28,9 @@ waLBerla_execute_test( NAME FlagFieldTest )
waLBerla_compile_test( FILES interpolators/InterpolationTest.cpp) waLBerla_compile_test( FILES interpolators/InterpolationTest.cpp)
waLBerla_execute_test( NAME InterpolationTest ) waLBerla_execute_test( NAME InterpolationTest )
waLBerla_compile_test( FILES interpolators/FieldInterpolationTest.cpp)
waLBerla_execute_test( NAME FieldInterpolationTest )
waLBerla_compile_test( FILES adaptors/AdaptorTest.cpp DEPENDS blockforest gui lbm ) waLBerla_compile_test( FILES adaptors/AdaptorTest.cpp DEPENDS blockforest gui lbm )
waLBerla_execute_test( NAME AdaptorTest ) waLBerla_execute_test( NAME AdaptorTest )
......
...@@ -16,6 +16,7 @@ ...@@ -16,6 +16,7 @@
//! \file FieldPackInfoTest.cpp //! \file FieldPackInfoTest.cpp
//! \ingroup field //! \ingroup field
//! \author Martin Bauer <martin.bauer@fau.de> //! \author Martin Bauer <martin.bauer@fau.de>
//! \author Christoph Rettinger <christoph.rettinger@fau.de>
//! \brief Tests if a Field is correctly packed into buffers //! \brief Tests if a Field is correctly packed into buffers
// //
//====================================================================================================================== //======================================================================================================================
...@@ -23,6 +24,7 @@ ...@@ -23,6 +24,7 @@
#include "field/AddToStorage.h" #include "field/AddToStorage.h"
#include "field/GhostLayerField.h" #include "field/GhostLayerField.h"
#include "field/communication/PackInfo.h" #include "field/communication/PackInfo.h"
#include "field/communication/UniformPullReductionPackInfo.h"
#include "blockforest/Initialization.h" #include "blockforest/Initialization.h"
...@@ -85,9 +87,60 @@ void testScalarField( IBlock * block, BlockDataID fieldId ) ...@@ -85,9 +87,60 @@ void testScalarField( IBlock * block, BlockDataID fieldId )
WALBERLA_CHECK_EQUAL ( field(1,1,+2), 4 ); WALBERLA_CHECK_EQUAL ( field(1,1,+2), 4 );
} }
void testScalarFieldPullReduction( IBlock * block, BlockDataID fieldId )
{
GhostLayerField<int,1> & field = *(block->getData<GhostLayerField<int,1> > (fieldId));
field.setWithGhostLayer( 0 );
WALBERLA_CHECK_EQUAL(field.xSize(), 2);
WALBERLA_CHECK_EQUAL(field.ySize(), 2);
WALBERLA_CHECK_EQUAL(field.zSize(), 2);
// initialize the bottom ghost layer cells
field(0,0,-1) = 1;
field(0,1,-1) = 2;
field(1,0,-1) = 3;
field(1,1,-1) = 4;
// initialize the top interior cells
field(0,0,1) = 1;
field(0,1,1) = 1;
field(1,0,1) = 1;
field(1,1,1) = 1;
// communicate periodic from bottom to top with uniform pull scheme
field::communication::UniformPullReductionPackInfo<std::plus, GhostLayerField<int,1> > pi1 (fieldId);
pi1.communicateLocal( block, block, stencil::B );
// check values in top ghost layer
WALBERLA_CHECK_EQUAL ( field(0,0,2), 0 );
WALBERLA_CHECK_EQUAL ( field(0,1,2), 0 );
WALBERLA_CHECK_EQUAL ( field(1,0,2), 0 );
WALBERLA_CHECK_EQUAL ( field(1,1,2), 0 );
// check values in top interior cells
WALBERLA_CHECK_EQUAL ( field(0,0,1), 2 );
WALBERLA_CHECK_EQUAL ( field(0,1,1), 3 );
WALBERLA_CHECK_EQUAL ( field(1,0,1), 4 );
WALBERLA_CHECK_EQUAL ( field(1,1,1), 5 );
// communicate periodic from top to bottom with standard form to sync ghost layers
field::communication::PackInfo< GhostLayerField<int,1> > pi2 (fieldId);
pi2.communicateLocal( block, block, stencil::T );
// check values in bottom ghost layer
WALBERLA_CHECK_EQUAL ( field(0,0,-1), 2 );
WALBERLA_CHECK_EQUAL ( field(0,1,-1), 3 );
WALBERLA_CHECK_EQUAL ( field(1,0,-1), 4 );
WALBERLA_CHECK_EQUAL ( field(1,1,-1), 5 );
// check values in top interior cells
WALBERLA_CHECK_EQUAL ( field(0,0,1), 2 );
WALBERLA_CHECK_EQUAL ( field(0,1,1), 3 );
WALBERLA_CHECK_EQUAL ( field(1,0,1), 4 );
WALBERLA_CHECK_EQUAL ( field(1,1,1), 5 );
}
int main(int argc, char **argv) int main(int argc, char **argv)
{ {
...@@ -127,7 +180,8 @@ int main(int argc, char **argv) ...@@ -127,7 +180,8 @@ int main(int argc, char **argv)
for( auto blockIt = blocks->begin(); blockIt != blocks->end(); ++blockIt ) // block loop for( auto blockIt = blocks->begin(); blockIt != blocks->end(); ++blockIt ) // block loop
testScalarField( &(*blockIt), scalarFieldId ); testScalarField( &(*blockIt), scalarFieldId );
for( auto blockIt = blocks->begin(); blockIt != blocks->end(); ++blockIt ) // block loop
testScalarFieldPullReduction( &(*blockIt), scalarFieldId );
return 0; return 0;
} }
This diff is collapsed.
This diff is collapsed.
0% or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment