Reference documentation for deal.II version 9.5.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Public Member Functions | Static Public Member Functions | Private Types | Private Member Functions | Private Attributes | Static Private Attributes | List of all members
PreconditionMG< dim, VectorType, TRANSFER > Class Template Reference

#include <deal.II/multigrid/multigrid.h>

Inheritance diagram for PreconditionMG< dim, VectorType, TRANSFER >:
[legend]

Public Member Functions

 PreconditionMG (const DoFHandler< dim > &dof_handler, Multigrid< VectorType > &mg, const TRANSFER &transfer)
 
 PreconditionMG (const std::vector< const DoFHandler< dim > * > &dof_handler, Multigrid< VectorType > &mg, const TRANSFER &transfer)
 
bool empty () const
 
template<class OtherVectorType >
void vmult (OtherVectorType &dst, const OtherVectorType &src) const
 
template<class OtherVectorType >
void vmult_add (OtherVectorType &dst, const OtherVectorType &src) const
 
template<class OtherVectorType >
void Tvmult (OtherVectorType &dst, const OtherVectorType &src) const
 
template<class OtherVectorType >
void Tvmult_add (OtherVectorType &dst, const OtherVectorType &src) const
 
IndexSet locally_owned_range_indices (const unsigned int block=0) const
 
IndexSet locally_owned_domain_indices (const unsigned int block=0) const
 
MPI_Comm get_mpi_communicator () const
 
boost::signals2::connection connect_transfer_to_mg (const std::function< void(bool)> &slot)
 
boost::signals2::connection connect_transfer_to_global (const std::function< void(bool)> &slot)
 
Multigrid< VectorType > & get_multigrid ()
 
const Multigrid< VectorType > & get_multigrid () const
 
template<class Archive >
void serialize (Archive &ar, const unsigned int version)
 
Subscriptor functionality

Classes derived from Subscriptor provide a facility to subscribe to this object. This is mostly used by the SmartPointer class.

void subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const
 
void unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const
 
unsigned int n_subscriptions () const
 
template<typename StreamType >
void list_subscribers (StreamType &stream) const
 
void list_subscribers () const
 

Static Public Member Functions

static ::ExceptionBaseExcInUse (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseExcNoSubscriber (std::string arg1, std::string arg2)
 

Private Types

using map_value_type = decltype(counter_map)::value_type
 
using map_iterator = decltype(counter_map)::iterator
 

Private Member Functions

void check_no_subscribers () const noexcept
 

Private Attributes

std::vector< SmartPointer< const DoFHandler< dim >, PreconditionMG< dim, VectorType, TRANSFER > > > dof_handler_vector
 
std::vector< const DoFHandler< dim > * > dof_handler_vector_raw
 
SmartPointer< Multigrid< VectorType >, PreconditionMG< dim, VectorType, TRANSFER > > multigrid
 
SmartPointer< const TRANSFER, PreconditionMG< dim, VectorType, TRANSFER > > transfer
 
const bool uses_dof_handler_vector
 
mg::Signals signals
 
std::atomic< unsigned intcounter
 
std::map< std::string, unsigned intcounter_map
 
std::vector< std::atomic< bool > * > validity_pointers
 
const std::type_info * object_info
 

Static Private Attributes

static std::mutex mutex
 

Detailed Description

template<int dim, typename VectorType, class TRANSFER>
class PreconditionMG< dim, VectorType, TRANSFER >

Multi-level preconditioner. Here, we collect all information needed for multi-level preconditioning and provide the standard interface for LAC iterative methods.

Furthermore, it needs functions void copy_to_mg(const VectorType&) to store src in the right hand side of the multi-level method and void copy_from_mg(VectorType&) to store the result of the v-cycle in dst.

If VectorType is in fact a block vector and the TRANSFER object supports use of a separate DoFHandler for each block, this class also allows to be initialized with a separate DoFHandler for each block.

Definition at line 501 of file multigrid.h.

Member Typedef Documentation

◆ map_value_type

using Subscriptor::map_value_type = decltype(counter_map)::value_type
privateinherited

The data type used in counter_map.

Definition at line 230 of file subscriptor.h.

◆ map_iterator

using Subscriptor::map_iterator = decltype(counter_map)::iterator
privateinherited

The iterator type used in counter_map.

Definition at line 235 of file subscriptor.h.

Constructor & Destructor Documentation

◆ PreconditionMG() [1/2]

template<int dim, typename VectorType , class TRANSFER >
PreconditionMG< dim, VectorType, TRANSFER >::PreconditionMG ( const DoFHandler< dim > &  dof_handler,
Multigrid< VectorType > &  mg,
const TRANSFER &  transfer 
)

Constructor. Arguments are the multigrid object, pre-smoother, post- smoother and coarse grid solver.

◆ PreconditionMG() [2/2]

template<int dim, typename VectorType , class TRANSFER >
PreconditionMG< dim, VectorType, TRANSFER >::PreconditionMG ( const std::vector< const DoFHandler< dim > * > &  dof_handler,
Multigrid< VectorType > &  mg,
const TRANSFER &  transfer 
)

Same as above in case every component of a block vector uses its own DoFHandler.

Member Function Documentation

◆ empty()

template<int dim, typename VectorType , class TRANSFER >
bool PreconditionMG< dim, VectorType, TRANSFER >::empty ( ) const

Dummy function needed by other classes.

◆ vmult()

template<int dim, typename VectorType , class TRANSFER >
template<class OtherVectorType >
void PreconditionMG< dim, VectorType, TRANSFER >::vmult ( OtherVectorType &  dst,
const OtherVectorType &  src 
) const

Preconditioning operator. Calls the vcycle function of the MG object passed to the constructor.

This is the operator used by LAC iterative solvers.

◆ vmult_add()

template<int dim, typename VectorType , class TRANSFER >
template<class OtherVectorType >
void PreconditionMG< dim, VectorType, TRANSFER >::vmult_add ( OtherVectorType &  dst,
const OtherVectorType &  src 
) const

Preconditioning operator. Calls the vcycle function of the MG object passed to the constructor.

◆ Tvmult()

template<int dim, typename VectorType , class TRANSFER >
template<class OtherVectorType >
void PreconditionMG< dim, VectorType, TRANSFER >::Tvmult ( OtherVectorType &  dst,
const OtherVectorType &  src 
) const

Transposed preconditioning operator.

Not implemented, but the definition may be needed.

◆ Tvmult_add()

template<int dim, typename VectorType , class TRANSFER >
template<class OtherVectorType >
void PreconditionMG< dim, VectorType, TRANSFER >::Tvmult_add ( OtherVectorType &  dst,
const OtherVectorType &  src 
) const

Transposed preconditioning operator.

Not implemented, but the definition may be needed.

◆ locally_owned_range_indices()

template<int dim, typename VectorType , class TRANSFER >
IndexSet PreconditionMG< dim, VectorType, TRANSFER >::locally_owned_range_indices ( const unsigned int  block = 0) const

Return the partitioning of the range space of this preconditioner, i.e., the partitioning of the vectors that are result from matrix-vector products. By default, the respective information for the first DoFHandler object are returned.

◆ locally_owned_domain_indices()

template<int dim, typename VectorType , class TRANSFER >
IndexSet PreconditionMG< dim, VectorType, TRANSFER >::locally_owned_domain_indices ( const unsigned int  block = 0) const

Return the partitioning of the domain space of this preconditioner, i.e., the partitioning of the vectors this matrix has to be multiplied with. By default, the respective information for the first DoFHandler object are returned.

◆ get_mpi_communicator()

template<int dim, typename VectorType , class TRANSFER >
MPI_Comm PreconditionMG< dim, VectorType, TRANSFER >::get_mpi_communicator ( ) const

Return the underlying MPI communicator.

◆ connect_transfer_to_mg()

template<int dim, typename VectorType , class TRANSFER >
boost::signals2::connection PreconditionMG< dim, VectorType, TRANSFER >::connect_transfer_to_mg ( const std::function< void(bool)> &  slot)

Connect a function to mg::Signals::transfer_to_mg.

◆ connect_transfer_to_global()

template<int dim, typename VectorType , class TRANSFER >
boost::signals2::connection PreconditionMG< dim, VectorType, TRANSFER >::connect_transfer_to_global ( const std::function< void(bool)> &  slot)

Connect a function to mg::Signals::transfer_to_global.

◆ get_multigrid() [1/2]

template<int dim, typename VectorType , class TRANSFER >
Multigrid< VectorType > & PreconditionMG< dim, VectorType, TRANSFER >::get_multigrid ( )

Return the Multigrid object passed to the constructor.

◆ get_multigrid() [2/2]

template<int dim, typename VectorType , class TRANSFER >
const Multigrid< VectorType > & PreconditionMG< dim, VectorType, TRANSFER >::get_multigrid ( ) const

Return the Multigrid object passed to the constructor.

◆ subscribe()

void Subscriptor::subscribe ( std::atomic< bool > *const  validity,
const std::string &  identifier = "" 
) const
inherited

Subscribes a user of the object by storing the pointer validity. The subscriber may be identified by text supplied as identifier.

Definition at line 136 of file subscriptor.cc.

◆ unsubscribe()

void Subscriptor::unsubscribe ( std::atomic< bool > *const  validity,
const std::string &  identifier = "" 
) const
inherited

Unsubscribes a user from the object.

Note
The identifier and the validity pointer must be the same as the one supplied to subscribe().

Definition at line 156 of file subscriptor.cc.

◆ n_subscriptions()

unsigned int Subscriptor::n_subscriptions ( ) const
inlineinherited

Return the present number of subscriptions to this object. This allows to use this class for reference counted lifetime determination where the last one to unsubscribe also deletes the object.

Definition at line 300 of file subscriptor.h.

◆ list_subscribers() [1/2]

template<typename StreamType >
void Subscriptor::list_subscribers ( StreamType &  stream) const
inlineinherited

List the subscribers to the input stream.

Definition at line 317 of file subscriptor.h.

◆ list_subscribers() [2/2]

void Subscriptor::list_subscribers ( ) const
inherited

List the subscribers to deallog.

Definition at line 204 of file subscriptor.cc.

◆ serialize()

template<class Archive >
void Subscriptor::serialize ( Archive &  ar,
const unsigned int  version 
)
inlineinherited

Read or write the data of this object to or from a stream for the purpose of serialization using the BOOST serialization library.

This function does not actually serialize any of the member variables of this class. The reason is that what this class stores is only who subscribes to this object, but who does so at the time of storing the contents of this object does not necessarily have anything to do with who subscribes to the object when it is restored. Consequently, we do not want to overwrite the subscribers at the time of restoring, and then there is no reason to write the subscribers out in the first place.

Definition at line 309 of file subscriptor.h.

◆ check_no_subscribers()

void Subscriptor::check_no_subscribers ( ) const
privatenoexceptinherited

Check that there are no objects subscribing to this object. If this check passes then it is safe to destroy the current object. It this check fails then this function will either abort or print an error message to deallog (by using the AssertNothrow mechanism), but will not throw an exception.

Note
Since this function is just a consistency check it does nothing in release mode.
If this function is called when there is an uncaught exception then, rather than aborting, this function prints an error message to the standard error stream and returns.

Definition at line 53 of file subscriptor.cc.

Member Data Documentation

◆ dof_handler_vector

template<int dim, typename VectorType , class TRANSFER >
std::vector<SmartPointer<const DoFHandler<dim>, PreconditionMG<dim, VectorType, TRANSFER> > > PreconditionMG< dim, VectorType, TRANSFER >::dof_handler_vector
private

Associated DoFHandler.

Definition at line 616 of file multigrid.h.

◆ dof_handler_vector_raw

template<int dim, typename VectorType , class TRANSFER >
std::vector<const DoFHandler<dim> *> PreconditionMG< dim, VectorType, TRANSFER >::dof_handler_vector_raw
private

Storage for the pointers to the DoFHandler objects without SmartPointer wrapper.

Definition at line 622 of file multigrid.h.

◆ multigrid

template<int dim, typename VectorType , class TRANSFER >
SmartPointer<Multigrid<VectorType>, PreconditionMG<dim, VectorType, TRANSFER> > PreconditionMG< dim, VectorType, TRANSFER >::multigrid
private

The multigrid object.

Definition at line 628 of file multigrid.h.

◆ transfer

template<int dim, typename VectorType , class TRANSFER >
SmartPointer<const TRANSFER, PreconditionMG<dim, VectorType, TRANSFER> > PreconditionMG< dim, VectorType, TRANSFER >::transfer
private

Object for grid transfer.

Definition at line 634 of file multigrid.h.

◆ uses_dof_handler_vector

template<int dim, typename VectorType , class TRANSFER >
const bool PreconditionMG< dim, VectorType, TRANSFER >::uses_dof_handler_vector
private

Flag to indicate if the object is initialized with a single DoFHandler or with one for each block.

Definition at line 640 of file multigrid.h.

◆ signals

template<int dim, typename VectorType , class TRANSFER >
mg::Signals PreconditionMG< dim, VectorType, TRANSFER >::signals
private

Signals used by this object

Definition at line 645 of file multigrid.h.

◆ counter

std::atomic<unsigned int> Subscriptor::counter
mutableprivateinherited

Store the number of objects which subscribed to this object. Initially, this number is zero, and upon destruction it shall be zero again (i.e. all objects which subscribed should have unsubscribed again).

The creator (and owner) of an object is counted in the map below if HE manages to supply identification.

We use the mutable keyword in order to allow subscription to constant objects also.

This counter may be read from and written to concurrently in multithreaded code: hence we use the std::atomic class template.

Definition at line 219 of file subscriptor.h.

◆ counter_map

std::map<std::string, unsigned int> Subscriptor::counter_map
mutableprivateinherited

In this map, we count subscriptions for each different identification string supplied to subscribe().

Definition at line 225 of file subscriptor.h.

◆ validity_pointers

std::vector<std::atomic<bool> *> Subscriptor::validity_pointers
mutableprivateinherited

In this vector, we store pointers to the validity bool in the SmartPointer objects that subscribe to this class.

Definition at line 241 of file subscriptor.h.

◆ object_info

const std::type_info* Subscriptor::object_info
mutableprivateinherited

Pointer to the typeinfo object of this object, from which we can later deduce the class name. Since this information on the derived class is neither available in the destructor, nor in the constructor, we obtain it in between and store it here.

Definition at line 249 of file subscriptor.h.

◆ mutex

std::mutex Subscriptor::mutex
staticprivateinherited

A mutex used to ensure data consistency when printing out the list of subscribers.

Definition at line 271 of file subscriptor.h.


The documentation for this class was generated from the following file: