|
| ParGridFunction () |
|
| ParGridFunction (ParFiniteElementSpace *pf) |
|
| ParGridFunction (ParFiniteElementSpace *pf, GridFunction *gf) |
|
| ParGridFunction (ParFiniteElementSpace *pf, HypreParVector *tv) |
|
| ParGridFunction (ParMesh *pmesh, GridFunction *gf, int *partitioning=NULL) |
|
ParGridFunction & | operator= (double value) |
|
ParGridFunction & | operator= (const Vector &v) |
|
ParFiniteElementSpace * | ParFESpace () |
|
void | Update () |
|
void | Update (ParFiniteElementSpace *f) |
|
void | Update (ParFiniteElementSpace *f, Vector &v, int v_offset) |
|
void | Distribute (const Vector *tv) |
|
void | Distribute (const Vector &tv) |
|
void | AddDistribute (double a, const Vector *tv) |
|
void | AddDistribute (double a, const Vector &tv) |
|
ParGridFunction & | operator= (const HypreParVector &tv) |
| Short semantic for Distribute. More...
|
|
void | GetTrueDofs (Vector &tv) const |
| Returns the true dofs in a Vector. More...
|
|
HypreParVector * | GetTrueDofs () const |
| Returns the true dofs in a new HypreParVector. More...
|
|
void | ParallelAverage (Vector &tv) const |
| Returns the vector averaged on the true dofs. More...
|
|
void | ParallelAverage (HypreParVector &tv) const |
| Returns the vector averaged on the true dofs. More...
|
|
HypreParVector * | ParallelAverage () const |
| Returns a new vector averaged on the true dofs. More...
|
|
void | ParallelProject (Vector &tv) const |
| Returns the vector restricted to the true dofs. More...
|
|
void | ParallelProject (HypreParVector &tv) const |
| Returns the vector restricted to the true dofs. More...
|
|
HypreParVector * | ParallelProject () const |
| Returns a new vector restricted to the true dofs. More...
|
|
void | ParallelAssemble (Vector &tv) const |
| Returns the vector assembled on the true dofs. More...
|
|
void | ParallelAssemble (HypreParVector &tv) const |
| Returns the vector assembled on the true dofs. More...
|
|
HypreParVector * | ParallelAssemble () const |
| Returns a new vector assembled on the true dofs. More...
|
|
void | ExchangeFaceNbrData () |
|
Vector & | FaceNbrData () |
|
const Vector & | FaceNbrData () const |
|
virtual double | GetValue (int i, const IntegrationPoint &ip, int vdim=1) const |
|
double | GetValue (ElementTransformation &T) |
|
void | ProjectCoefficient (Coefficient &coeff) |
|
void | ProjectDiscCoefficient (VectorCoefficient &coeff) |
|
double | ComputeL1Error (Coefficient *exsol[], const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL1Error (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL1Error (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL2Error (Coefficient *exsol[], const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL2Error (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL2Error (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL, Array< int > *elems=NULL) const |
|
double | ComputeMaxError (Coefficient *exsol[], const IntegrationRule *irs[]=NULL) const |
|
double | ComputeMaxError (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeMaxError (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeLpError (const double p, Coefficient &exsol, Coefficient *weight=NULL, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeLpError (const double p, VectorCoefficient &exsol, Coefficient *weight=NULL, VectorCoefficient *v_weight=NULL, const IntegrationRule *irs[]=NULL) const |
|
virtual void | ComputeFlux (BilinearFormIntegrator &blfi, GridFunction &flux, int wcoef=1, int subdomain=-1) |
|
virtual void | Save (std::ostream &out) const |
|
void | SaveAsOne (std::ostream &out=std::cout) |
| Merge the local grid functions. More...
|
|
virtual | ~ParGridFunction () |
|
| GridFunction () |
|
| GridFunction (FiniteElementSpace *f) |
| Creates grid function associated with *f. More...
|
|
| GridFunction (Mesh *m, std::istream &input) |
|
| GridFunction (Mesh *m, GridFunction *gf_array[], int num_pieces) |
|
void | MakeOwner (FiniteElementCollection *_fec) |
| Make the GridFunction the owner of 'fec' and 'fes'. More...
|
|
FiniteElementCollection * | OwnFEC () |
|
int | VectorDim () const |
|
void | GetNodalValues (int i, Array< double > &nval, int vdim=1) const |
| Returns the values in the vertices of i'th element for dimension vdim. More...
|
|
void | GetVectorValue (int i, const IntegrationPoint &ip, Vector &val) const |
|
void | GetValues (int i, const IntegrationRule &ir, Vector &vals, int vdim=1) const |
|
void | GetValues (int i, const IntegrationRule &ir, Vector &vals, DenseMatrix &tr, int vdim=1) const |
|
int | GetFaceValues (int i, int side, const IntegrationRule &ir, Vector &vals, DenseMatrix &tr, int vdim=1) const |
|
void | GetVectorValues (ElementTransformation &T, const IntegrationRule &ir, DenseMatrix &vals) const |
|
void | GetVectorValues (int i, const IntegrationRule &ir, DenseMatrix &vals, DenseMatrix &tr) const |
|
int | GetFaceVectorValues (int i, int side, const IntegrationRule &ir, DenseMatrix &vals, DenseMatrix &tr) const |
|
void | GetValuesFrom (GridFunction &) |
|
void | GetBdrValuesFrom (GridFunction &) |
|
void | GetVectorFieldValues (int i, const IntegrationRule &ir, DenseMatrix &vals, DenseMatrix &tr, int comp=0) const |
|
void | ReorderByNodes () |
| For a vector grid function, makes sure that the ordering is byNODES. More...
|
|
void | GetNodalValues (Vector &nval, int vdim=1) const |
| Return the values as a vector on mesh vertices for dimension vdim. More...
|
|
void | GetVectorFieldNodalValues (Vector &val, int comp) const |
|
void | ProjectVectorFieldOn (GridFunction &vec_field, int comp=0) |
|
void | GetDerivative (int comp, int der_comp, GridFunction &der) |
|
double | GetDivergence (ElementTransformation &tr) |
|
void | GetCurl (ElementTransformation &tr, Vector &curl) |
|
void | GetGradient (ElementTransformation &tr, Vector &grad) |
|
void | GetGradients (const int elem, const IntegrationRule &ir, DenseMatrix &grad) |
|
void | GetVectorGradient (ElementTransformation &tr, DenseMatrix &grad) |
|
void | GetElementAverages (GridFunction &avgs) |
|
void | ImposeBounds (int i, const Vector &weights, const Vector &_lo, const Vector &_hi) |
|
void | ImposeBounds (int i, const Vector &weights, double _min=0.0, double _max=std::numeric_limits< double >::infinity()) |
|
void | ProjectGridFunction (const GridFunction &src) |
|
void | ProjectCoefficient (Coefficient &coeff) |
|
void | ProjectCoefficient (Coefficient &coeff, Array< int > &dofs, int vd=0) |
|
void | ProjectCoefficient (VectorCoefficient &vcoeff) |
|
void | ProjectCoefficient (VectorCoefficient &vcoeff, Array< int > &dofs) |
|
void | ProjectCoefficient (Coefficient *coeff[]) |
|
void | ProjectDiscCoefficient (VectorCoefficient &coeff) |
|
void | ProjectBdrCoefficient (Coefficient &coeff, Array< int > &attr) |
|
void | ProjectBdrCoefficient (Coefficient *coeff[], Array< int > &attr) |
|
void | ProjectBdrCoefficientNormal (VectorCoefficient &vcoeff, Array< int > &bdr_attr) |
|
void | ProjectBdrCoefficientTangent (VectorCoefficient &vcoeff, Array< int > &bdr_attr) |
|
double | ComputeL2Error (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL2Error (Coefficient *exsol[], const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL2Error (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL, Array< int > *elems=NULL) const |
|
double | ComputeH1Error (Coefficient *exsol, VectorCoefficient *exgrad, Coefficient *ell_coef, double Nu, int norm_type) const |
|
double | ComputeMaxError (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeMaxError (Coefficient *exsol[], const IntegrationRule *irs[]=NULL) const |
|
double | ComputeMaxError (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL1Error (Coefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeW11Error (Coefficient *exsol, VectorCoefficient *exgrad, int norm_type, Array< int > *elems=NULL, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeL1Error (VectorCoefficient &exsol, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeLpError (const double p, Coefficient &exsol, Coefficient *weight=NULL, const IntegrationRule *irs[]=NULL) const |
|
double | ComputeLpError (const double p, VectorCoefficient &exsol, Coefficient *weight=NULL, VectorCoefficient *v_weight=NULL, const IntegrationRule *irs[]=NULL) const |
|
GridFunction & | operator= (double value) |
| Redefine '=' for GridFunction = constant. More...
|
|
GridFunction & | operator= (const Vector &v) |
|
GridFunction & | operator= (const GridFunction &v) |
|
void | ConformingProlongate (const Vector &x) |
|
void | ConformingProlongate () |
|
void | ConformingProject (Vector &x) const |
|
void | ConformingProject () |
|
FiniteElementSpace * | FESpace () |
|
void | Update () |
|
void | Update (FiniteElementSpace *f) |
|
void | Update (FiniteElementSpace *f, Vector &v, int v_offset) |
|
void | SaveVTK (std::ostream &out, const std::string &field_name, int ref) |
|
void | SaveSTL (std::ostream &out, int TimesToRefine=1) |
|
virtual | ~GridFunction () |
| Destroys grid function. More...
|
|
| Vector () |
| Default constructor for Vector. Sets size = 0 and data = NULL. More...
|
|
| Vector (const Vector &) |
| Copy constructor. More...
|
|
| Vector (int s) |
| Creates vector of size s. More...
|
|
| Vector (double *_data, int _size) |
| Creates a vector referencing an array of doubles, owned by someone else. More...
|
|
void | Load (std::istream **in, int np, int *dim) |
| Reads a vector from multiple files. More...
|
|
void | Load (std::istream &in, int Size) |
| Load a vector from an input stream. More...
|
|
void | Load (std::istream &in) |
| Load a vector from an input stream. More...
|
|
void | SetSize (int s) |
| Resizes the vector if the new size is different. More...
|
|
void | SetData (double *d) |
|
void | SetDataAndSize (double *d, int s) |
|
void | NewDataAndSize (double *d, int s) |
|
void | MakeDataOwner () |
|
void | Destroy () |
| Destroy a vector. More...
|
|
int | Size () const |
| Returns the size of the vector. More...
|
|
double * | GetData () const |
|
| operator double * () |
|
| operator const double * () const |
|
bool | OwnsData () const |
|
void | StealData (double **p) |
| Changes the ownership of the data; after the call the Vector is empty. More...
|
|
double * | StealData () |
| Changes the ownership of the data; after the call the Vector is empty. More...
|
|
double & | Elem (int i) |
| Sets value in vector. Index i = 0 .. size-1. More...
|
|
const double & | Elem (int i) const |
| Sets value in vector. Index i = 0 .. size-1. More...
|
|
double & | operator() (int i) |
| Sets value in vector. Index i = 0 .. size-1. More...
|
|
const double & | operator() (int i) const |
| Sets value in vector. Index i = 0 .. size-1. More...
|
|
double | operator* (const double *) const |
|
double | operator* (const Vector &v) const |
| Return the inner-product. More...
|
|
Vector & | operator= (const double *v) |
|
Vector & | operator= (const Vector &v) |
| Redefine '=' for vector = vector. More...
|
|
Vector & | operator= (double value) |
| Redefine '=' for vector = constant. More...
|
|
Vector & | operator*= (double c) |
|
Vector & | operator/= (double c) |
|
Vector & | operator-= (double c) |
|
Vector & | operator-= (const Vector &v) |
|
Vector & | operator+= (const Vector &v) |
|
Vector & | Add (const double a, const Vector &Va) |
| (*this) += a * Va More...
|
|
Vector & | Set (const double a, const Vector &x) |
| (*this) = a * x More...
|
|
void | SetVector (const Vector &v, int offset) |
|
void | Neg () |
| (*this) = -(*this) More...
|
|
void | Swap (Vector &other) |
| Swap the contents of two Vectors. More...
|
|
void | median (const Vector &lo, const Vector &hi) |
| v = median(v,lo,hi) entrywise. Implementation assumes lo <= hi. More...
|
|
void | GetSubVector (const Array< int > &dofs, Vector &elemvect) const |
|
void | GetSubVector (const Array< int > &dofs, double *elem_data) const |
|
void | SetSubVector (const Array< int > &dofs, const Vector &elemvect) |
|
void | SetSubVector (const Array< int > &dofs, double *elem_data) |
|
void | AddElementVector (const Array< int > &dofs, const Vector &elemvect) |
| Add (element) subvector to the vector. More...
|
|
void | AddElementVector (const Array< int > &dofs, double *elem_data) |
|
void | AddElementVector (const Array< int > &dofs, const double a, const Vector &elemvect) |
|
void | SetSubVectorComplement (const Array< int > &dofs, const double val) |
| Set all vector entries NOT in the 'dofs' array to the given 'val'. More...
|
|
void | Print (std::ostream &out=std::cout, int width=8) const |
| Prints vector to stream out. More...
|
|
void | Print_HYPRE (std::ostream &out) const |
| Prints vector to stream out in HYPRE_Vector format. More...
|
|
void | Randomize (int seed=0) |
| Set random values in the vector. More...
|
|
double | Norml2 () const |
| Returns the l2 norm of the vector. More...
|
|
double | Normlinf () const |
| Returns the l_infinity norm of the vector. More...
|
|
double | Norml1 () const |
| Returns the l_1 norm of the vector. More...
|
|
double | Normlp (double p) const |
| Returns the l_p norm of the vector. More...
|
|
double | Max () const |
| Returns the maximal element of the vector. More...
|
|
double | Min () const |
| Returns the minimal element of the vector. More...
|
|
double | Sum () const |
| Return the sum of the vector entries. More...
|
|
double | DistanceTo (const double *p) const |
| Compute the Euclidean distance to another vector. More...
|
|
int | CheckFinite () const |
|
virtual | ~Vector () |
| Destroys vector. More...
|
|