Skip to content
Snippets Groups Projects
Commit ef779d07 authored by Christophe Geuzaine's avatar Christophe Geuzaine
Browse files

gmshFunction -> simpleFunction

parent 7066700a
No related branches found
No related tags found
No related merge requests found
...@@ -700,7 +700,7 @@ void GFaceCompound::parametrize(iterationStep step) const ...@@ -700,7 +700,7 @@ void GFaceCompound::parametrize(iterationStep step) const
Msg::Info("Parametrizing Surface %d coordinate (ITER %d)", tag(), step); Msg::Info("Parametrizing Surface %d coordinate (ITER %d)", tag(), step);
gmshAssembler<double> myAssembler(_lsys); gmshAssembler<double> myAssembler(_lsys);
gmshFunction<double> ONE(1.0); simpleFunction<double> ONE(1.0);
if(_type == UNITCIRCLE){ if(_type == UNITCIRCLE){
// maps the boundary onto a circle // maps the boundary onto a circle
...@@ -849,8 +849,8 @@ void GFaceCompound::parametrize_conformal() const ...@@ -849,8 +849,8 @@ void GFaceCompound::parametrize_conformal() const
} }
} }
gmshFunction<double> ONE(1.0); simpleFunction<double> ONE(1.0);
gmshFunction<double> MONE(-1.0 ); simpleFunction<double> MONE(-1.0 );
gmshLaplaceTerm laplace1(model(), &ONE, 1); gmshLaplaceTerm laplace1(model(), &ONE, 1);
gmshLaplaceTerm laplace2(model(), &ONE, 2); gmshLaplaceTerm laplace2(model(), &ONE, 2);
gmshCrossConfTerm cross12(model(), &ONE, 1 , 2); gmshCrossConfTerm cross12(model(), &ONE, 1 , 2);
...@@ -900,7 +900,7 @@ void GFaceCompound::compute_distance() const ...@@ -900,7 +900,7 @@ void GFaceCompound::compute_distance() const
double L = norm(SVector3(bbox.max(), bbox.min())); double L = norm(SVector3(bbox.max(), bbox.min()));
//printf("L=%g \n", L); //printf("L=%g \n", L);
double mu = L/28; double mu = L/28;
gmshFunction<double> DIFF(mu*mu); simpleFunction<double> DIFF(mu*mu);
gmshAssembler<double> myAssembler(_lsys); gmshAssembler<double> myAssembler(_lsys);
gmshDistanceTerm distance(model(), &DIFF, 1); gmshDistanceTerm distance(model(), &DIFF, 1);
......
...@@ -7,7 +7,7 @@ ...@@ -7,7 +7,7 @@
#define _GMSH_CONVEX_H_ #define _GMSH_CONVEX_H_
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -15,7 +15,7 @@ ...@@ -15,7 +15,7 @@
class gmshConvexCombinationTerm : public gmshNodalFemTerm<double> { class gmshConvexCombinationTerm : public gmshNodalFemTerm<double> {
protected: protected:
const gmshFunction<double> *_diffusivity; const simpleFunction<double> *_diffusivity;
const int _iField ; const int _iField ;
public: public:
virtual int sizeOfR(MElement *e) const { return e->getNumVertices(); } virtual int sizeOfR(MElement *e) const { return e->getNumVertices(); }
...@@ -27,7 +27,7 @@ class gmshConvexCombinationTerm : public gmshNodalFemTerm<double> { ...@@ -27,7 +27,7 @@ class gmshConvexCombinationTerm : public gmshNodalFemTerm<double> {
*iFieldR = _iField; *iFieldR = _iField;
} }
public: public:
gmshConvexCombinationTerm(GModel *gm, gmshFunction<double> *diffusivity, int iField = 0) : gmshConvexCombinationTerm(GModel *gm, simpleFunction<double> *diffusivity, int iField = 0) :
gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField){} gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField){}
virtual void elementMatrix(MElement *e, fullMatrix<double> &m) const; virtual void elementMatrix(MElement *e, fullMatrix<double> &m) const;
}; };
......
...@@ -9,7 +9,7 @@ ...@@ -9,7 +9,7 @@
#define _GMSH_CROSSCONF_H_ #define _GMSH_CROSSCONF_H_
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -17,7 +17,7 @@ ...@@ -17,7 +17,7 @@
class gmshCrossConfTerm : public gmshNodalFemTerm<double> { class gmshCrossConfTerm : public gmshNodalFemTerm<double> {
protected: protected:
const gmshFunction<double> *_diffusivity; const simpleFunction<double> *_diffusivity;
const int _iField; const int _iField;
int _iFieldB ; int _iFieldB ;
public: public:
...@@ -36,7 +36,7 @@ class gmshCrossConfTerm : public gmshNodalFemTerm<double> { ...@@ -36,7 +36,7 @@ class gmshCrossConfTerm : public gmshNodalFemTerm<double> {
*iFieldR = _iFieldB; *iFieldR = _iFieldB;
} }
public: public:
gmshCrossConfTerm(GModel *gm, gmshFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) : gmshCrossConfTerm(GModel *gm, simpleFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) :
gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField) gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField)
{ {
_iFieldB = (iFieldB==-1) ? _iField : iFieldB; _iFieldB = (iFieldB==-1) ? _iField : iFieldB;
...@@ -47,7 +47,7 @@ class gmshCrossConfTerm : public gmshNodalFemTerm<double> { ...@@ -47,7 +47,7 @@ class gmshCrossConfTerm : public gmshNodalFemTerm<double> {
class gmshCrossConfTerm2DParametric : gmshCrossConfTerm { class gmshCrossConfTerm2DParametric : gmshCrossConfTerm {
GFace *_gf; GFace *_gf;
public: public:
gmshCrossConfTerm2DParametric(GFace *gf, gmshFunction<double> *diffusivity, int iField = 0) : gmshCrossConfTerm2DParametric(GFace *gf, simpleFunction<double> *diffusivity, int iField = 0) :
gmshCrossConfTerm(gf->model(), diffusivity, iField), _gf(gf) {} gmshCrossConfTerm(gf->model(), diffusivity, iField), _gf(gf) {}
virtual void elementMatrix(MElement *e, fullMatrix<double> &m) const; virtual void elementMatrix(MElement *e, fullMatrix<double> &m) const;
}; };
......
...@@ -9,7 +9,7 @@ ...@@ -9,7 +9,7 @@
#define _GMSH_DISTANCE_H_ #define _GMSH_DISTANCE_H_
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -17,7 +17,7 @@ ...@@ -17,7 +17,7 @@
class gmshDistanceTerm : public gmshNodalFemTerm<double> { class gmshDistanceTerm : public gmshNodalFemTerm<double> {
protected: protected:
const gmshFunction<double> *_diffusivity; const simpleFunction<double> *_diffusivity;
const int _iField; const int _iField;
int _iFieldB ; int _iFieldB ;
public: public:
...@@ -36,7 +36,7 @@ class gmshDistanceTerm : public gmshNodalFemTerm<double> { ...@@ -36,7 +36,7 @@ class gmshDistanceTerm : public gmshNodalFemTerm<double> {
*iFieldR = _iFieldB; *iFieldR = _iFieldB;
} }
public: public:
gmshDistanceTerm(GModel *gm, gmshFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) : gmshDistanceTerm(GModel *gm, simpleFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) :
gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField) gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField)
{ {
_iFieldB = (iFieldB==-1) ? _iField : iFieldB; _iFieldB = (iFieldB==-1) ? _iField : iFieldB;
......
...@@ -10,7 +10,7 @@ ...@@ -10,7 +10,7 @@
#include <complex> #include <complex>
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -18,7 +18,7 @@ ...@@ -18,7 +18,7 @@
class gmshHelmholtzTerm : public gmshNodalFemTerm<std::complex<double> > { class gmshHelmholtzTerm : public gmshNodalFemTerm<std::complex<double> > {
private: private:
const gmshFunction<std::complex<double> > *_waveNumber; const simpleFunction<std::complex<double> > *_waveNumber;
const int _iField ; const int _iField ;
protected: protected:
virtual int sizeOfR(MElement *e) const { return e->getNumVertices(); } virtual int sizeOfR(MElement *e) const { return e->getNumVertices(); }
...@@ -30,7 +30,7 @@ class gmshHelmholtzTerm : public gmshNodalFemTerm<std::complex<double> > { ...@@ -30,7 +30,7 @@ class gmshHelmholtzTerm : public gmshNodalFemTerm<std::complex<double> > {
*iFieldR = _iField; *iFieldR = _iField;
} }
public: public:
gmshHelmholtzTerm(GModel *gm, gmshFunction<std::complex<double> > *waveNumber, gmshHelmholtzTerm(GModel *gm, simpleFunction<std::complex<double> > *waveNumber,
int iField = 0) int iField = 0)
: gmshNodalFemTerm<std::complex<double> >(gm), _waveNumber(waveNumber), _iField(iField){} : gmshNodalFemTerm<std::complex<double> >(gm), _waveNumber(waveNumber), _iField(iField){}
virtual void elementMatrix(MElement *e, fullMatrix<std::complex<double> > &m) const; virtual void elementMatrix(MElement *e, fullMatrix<std::complex<double> > &m) const;
......
...@@ -9,7 +9,7 @@ ...@@ -9,7 +9,7 @@
#define _GMSH_LAPLACE_H_ #define _GMSH_LAPLACE_H_
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -17,7 +17,7 @@ ...@@ -17,7 +17,7 @@
class gmshLaplaceTerm : public gmshNodalFemTerm<double> { class gmshLaplaceTerm : public gmshNodalFemTerm<double> {
protected: protected:
const gmshFunction<double> *_diffusivity; const simpleFunction<double> *_diffusivity;
const int _iField; const int _iField;
int _iFieldB ; int _iFieldB ;
public: public:
...@@ -36,7 +36,7 @@ class gmshLaplaceTerm : public gmshNodalFemTerm<double> { ...@@ -36,7 +36,7 @@ class gmshLaplaceTerm : public gmshNodalFemTerm<double> {
*iFieldR = _iFieldB; *iFieldR = _iFieldB;
} }
public: public:
gmshLaplaceTerm(GModel *gm, gmshFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) : gmshLaplaceTerm(GModel *gm, simpleFunction<double> *diffusivity, int iField = 0, int iFieldB=-1) :
gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField) gmshNodalFemTerm<double>(gm), _diffusivity(diffusivity), _iField(iField)
{ {
_iFieldB = (iFieldB==-1) ? _iField : iFieldB; _iFieldB = (iFieldB==-1) ? _iField : iFieldB;
......
...@@ -9,7 +9,7 @@ ...@@ -9,7 +9,7 @@
#define _GMSH_PROJECTION_H_ #define _GMSH_PROJECTION_H_
#include "gmshTermOfFormulation.h" #include "gmshTermOfFormulation.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
......
...@@ -12,7 +12,7 @@ ...@@ -12,7 +12,7 @@
#include <map> #include <map>
#include <vector> #include <vector>
#include "fullMatrix.h" #include "fullMatrix.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "gmshAssembler.h" #include "gmshAssembler.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -107,7 +107,7 @@ class gmshNodalFemTerm : public gmshTermOfFormulation<scalar> { ...@@ -107,7 +107,7 @@ class gmshNodalFemTerm : public gmshTermOfFormulation<scalar> {
int dim, int dim,
int comp, int comp,
int field, int field,
const gmshFunction<scalar> &e, const simpleFunction<scalar> &e,
gmshAssembler<scalar> &lsys) gmshAssembler<scalar> &lsys)
{ {
std::vector<MVertex *> v; std::vector<MVertex *> v;
...@@ -120,7 +120,7 @@ class gmshNodalFemTerm : public gmshTermOfFormulation<scalar> { ...@@ -120,7 +120,7 @@ class gmshNodalFemTerm : public gmshTermOfFormulation<scalar> {
int dim, int dim,
int comp, int comp,
int field, int field,
const gmshFunction<scalar> &fct, const simpleFunction<scalar> &fct,
gmshAssembler<scalar> &lsys) gmshAssembler<scalar> &lsys)
{ {
std::map<int, std::vector<GEntity*> > groups[4]; std::map<int, std::vector<GEntity*> > groups[4];
......
// THIS FILE WILL BE REMOVED AS SOON AS THE NEW SOLVER INTERFACE IS READY
// Gmsh - Copyright (C) 1997-2009 C. Geuzaine, J.-F. Remacle // Gmsh - Copyright (C) 1997-2009 C. Geuzaine, J.-F. Remacle
// //
// See the LICENSE.txt file for license information. Please report all // See the LICENSE.txt file for license information. Please report all
// bugs and problems to <gmsh@geuz.org>. // bugs and problems to <gmsh@geuz.org>.
#ifndef _GMSH_FUNCTION_H_ #ifndef _SIMPLE_FUNCTION_H_
#define _GMSH_FUNCTION_H_ #define _SIMPLE_FUNCTION_H_
template <class scalar> template <class scalar>
class gmshFunction { class simpleFunction {
scalar _val; scalar _val;
public : public :
gmshFunction(scalar val=0) : _val(val) {} simpleFunction(scalar val=0) : _val(val) {}
virtual ~gmshFunction(){} virtual ~simpleFunction(){}
virtual scalar operator () (double x, double y, double z) const { return _val; } virtual scalar operator () (double x, double y, double z) const { return _val; }
}; };
......
...@@ -68,7 +68,7 @@ StringXString *GMSH_FiniteElementPlugin::getOptionStr(int iopt) ...@@ -68,7 +68,7 @@ StringXString *GMSH_FiniteElementPlugin::getOptionStr(int iopt)
} }
template<class scalar> template<class scalar>
class gmshMathEvalFunction : public gmshFunction<scalar> { class gmshMathEvalFunction : public simpleFunction<scalar> {
private: private:
std::string _str; std::string _str;
mathEvaluator *_f; mathEvaluator *_f;
......
...@@ -151,7 +151,7 @@ void elasticitySolver::solve() ...@@ -151,7 +151,7 @@ void elasticitySolver::solve()
it != edgeDisplacements.end(); ++it){ it != edgeDisplacements.end(); ++it){
elasticityTerm El(pModel, 1, 1, _tag); elasticityTerm El(pModel, 1, 1, _tag);
El.dirichletNodalBC(it->first.first, 1, it->first.second, _tag, El.dirichletNodalBC(it->first.first, 1, it->first.second, _tag,
gmshFunction<double>(it->second), *pAssembler); simpleFunction<double>(it->second), *pAssembler);
printf("-- Fixing edge %3d comp %1d to %8.5f\n", printf("-- Fixing edge %3d comp %1d to %8.5f\n",
it->first.first, it->first.second, it->second); it->first.first, it->first.second, it->second);
} }
...@@ -160,7 +160,7 @@ void elasticitySolver::solve() ...@@ -160,7 +160,7 @@ void elasticitySolver::solve()
it != faceDisplacements.end(); ++it){ it != faceDisplacements.end(); ++it){
elasticityTerm El(pModel, 1, 1, _tag); elasticityTerm El(pModel, 1, 1, _tag);
El.dirichletNodalBC(it->first.first, 2, it->first.second, _tag, El.dirichletNodalBC(it->first.first, 2, it->first.second, _tag,
gmshFunction<double>(it->second), *pAssembler); simpleFunction<double>(it->second), *pAssembler);
printf("-- Fixing face %3d comp %1d to %8.5f\n", printf("-- Fixing face %3d comp %1d to %8.5f\n",
it->first.first, it->first.second, it->second); it->first.first, it->first.second, it->second);
} }
...@@ -203,9 +203,9 @@ void elasticitySolver::solve() ...@@ -203,9 +203,9 @@ void elasticitySolver::solve()
elasticityTerm El(pModel, 1, 1, _tag); elasticityTerm El(pModel, 1, 1, _tag);
int iEdge = it->first; int iEdge = it->first;
SVector3 f = it->second; SVector3 f = it->second;
El.neumannNodalBC(iEdge, 1, 0, _tag, gmshFunction<double>(f.x()), *pAssembler); El.neumannNodalBC(iEdge, 1, 0, _tag, simpleFunction<double>(f.x()), *pAssembler);
El.neumannNodalBC(iEdge, 1, 1, _tag, gmshFunction<double>(f.y()), *pAssembler); El.neumannNodalBC(iEdge, 1, 1, _tag, simpleFunction<double>(f.y()), *pAssembler);
El.neumannNodalBC(iEdge, 1, 2, _tag, gmshFunction<double>(f.z()), *pAssembler); El.neumannNodalBC(iEdge, 1, 2, _tag, simpleFunction<double>(f.z()), *pAssembler);
printf("-- Force on edge %3d : %8.5f %8.5f %8.5f\n", iEdge, f.x(), f.y(), f.z()); printf("-- Force on edge %3d : %8.5f %8.5f %8.5f\n", iEdge, f.x(), f.y(), f.z());
} }
...@@ -215,9 +215,9 @@ void elasticitySolver::solve() ...@@ -215,9 +215,9 @@ void elasticitySolver::solve()
elasticityTerm El(pModel, 1, 1, _tag); elasticityTerm El(pModel, 1, 1, _tag);
int iFace = it->first; int iFace = it->first;
SVector3 f = it->second; SVector3 f = it->second;
El.neumannNodalBC(iFace, 2, 0, _tag, gmshFunction<double>(f.x()), *pAssembler); El.neumannNodalBC(iFace, 2, 0, _tag, simpleFunction<double>(f.x()), *pAssembler);
El.neumannNodalBC(iFace, 2, 1, _tag, gmshFunction<double>(f.y()), *pAssembler); El.neumannNodalBC(iFace, 2, 1, _tag, simpleFunction<double>(f.y()), *pAssembler);
El.neumannNodalBC(iFace, 2, 2, _tag, gmshFunction<double>(f.z()), *pAssembler); El.neumannNodalBC(iFace, 2, 2, _tag, simpleFunction<double>(f.z()), *pAssembler);
printf("-- Force on face %3d : %8.5f %8.5f %8.5f\n", iFace, f.x(), f.y(), f.z()); printf("-- Force on face %3d : %8.5f %8.5f %8.5f\n", iFace, f.x(), f.y(), f.z());
} }
......
...@@ -10,7 +10,7 @@ ...@@ -10,7 +10,7 @@
#include <map> #include <map>
#include <vector> #include <vector>
#include "fullMatrix.h" #include "fullMatrix.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "dofManager.h" #include "dofManager.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -72,7 +72,7 @@ class femTerm { ...@@ -72,7 +72,7 @@ class femTerm {
} }
} }
void dirichletNodalBC(int physical, int dim, int comp, int field, void dirichletNodalBC(int physical, int dim, int comp, int field,
const gmshFunction<dataVec> &e, const simpleFunction<dataVec> &e,
dofManager<dataVec,dataMat> &dm) dofManager<dataVec,dataMat> &dm)
{ {
std::vector<MVertex *> v; std::vector<MVertex *> v;
...@@ -82,7 +82,7 @@ class femTerm { ...@@ -82,7 +82,7 @@ class femTerm {
dm.fixVertex(v[i], comp, field, e(v[i]->x(), v[i]->y(), v[i]->z())); dm.fixVertex(v[i], comp, field, e(v[i]->x(), v[i]->y(), v[i]->z()));
} }
void neumannNodalBC(int physical, int dim, int comp,int field, void neumannNodalBC(int physical, int dim, int comp,int field,
const gmshFunction<dataVec> &fct, const simpleFunction<dataVec> &fct,
dofManager<dataVec,dataMat> &dm) dofManager<dataVec,dataMat> &dm)
{ {
std::map<int, std::vector<GEntity*> > groups[4]; std::map<int, std::vector<GEntity*> > groups[4];
......
...@@ -8,7 +8,7 @@ ...@@ -8,7 +8,7 @@
#include <assert.h> #include <assert.h>
#include "femTerm.h" #include "femTerm.h"
#include "gmshFunction.h" #include "simpleFunction.h"
#include "Gmsh.h" #include "Gmsh.h"
#include "GModel.h" #include "GModel.h"
#include "MElement.h" #include "MElement.h"
...@@ -19,7 +19,7 @@ ...@@ -19,7 +19,7 @@
template<class scalar> template<class scalar>
class helmoltzTerm : public femTerm<scalar, scalar> { class helmoltzTerm : public femTerm<scalar, scalar> {
protected: protected:
const gmshFunction<scalar> *_k, *_a; const simpleFunction<scalar> *_k, *_a;
const int _iFieldR; const int _iFieldR;
int _iFieldC ; int _iFieldC ;
public: public:
...@@ -36,8 +36,8 @@ class helmoltzTerm : public femTerm<scalar, scalar> { ...@@ -36,8 +36,8 @@ class helmoltzTerm : public femTerm<scalar, scalar> {
} }
public: public:
helmoltzTerm(GModel *gm, int iFieldR, int iFieldC, helmoltzTerm(GModel *gm, int iFieldR, int iFieldC,
gmshFunction<scalar> *k, simpleFunction<scalar> *k,
gmshFunction<scalar> *a) : simpleFunction<scalar> *a) :
femTerm<scalar,scalar>(gm), _k(k), _a(a), _iFieldR(iFieldR), _iFieldC(iFieldC){} femTerm<scalar,scalar>(gm), _k(k), _a(a), _iFieldR(iFieldR), _iFieldC(iFieldC){}
virtual void elementMatrix(MElement *e, fullMatrix<scalar> &m) const virtual void elementMatrix(MElement *e, fullMatrix<scalar> &m) const
{ {
......
...@@ -11,17 +11,17 @@ ...@@ -11,17 +11,17 @@
// \nabla \cdot k \nabla U // \nabla \cdot k \nabla U
template<class scalar> template<class scalar>
class laplaceTerm : public helmholtzTerm<scalar> { class laplaceTerm : public helmholtzTerm<scalar> {
gmshFunction<scalar> *ONE; simpleFunction<scalar> *ONE;
public: public:
laplaceTerm(GModel *gm, int iFieldR) : laplaceTerm(GModel *gm, int iFieldR) :
helmholtzTerm<scalar>(gm, iFieldR, iFieldR, 0, 0) helmholtzTerm<scalar>(gm, iFieldR, iFieldR, 0, 0)
{ {
ONE = new gmshFunction<scalar>(1.0); ONE = new simpleFunction<scalar>(1.0);
_k = ONE; _k = ONE;
} }
laplaceTerm(GModel *gm, int iFieldR, gmshFunction<scalar> *k) : laplaceTerm(GModel *gm, int iFieldR, simpleFunction<scalar> *k) :
helmholtzTerm<scalar>(gm, iFieldR, iFieldR, k, 0), ONE(0) {} helmholtzTerm<scalar>(gm, iFieldR, iFieldR, k, 0), ONE(0) {}
laplaceTerm(GModel *gm, int iFieldR, int iFieldC, gmshFunction<scalar> *k) : laplaceTerm(GModel *gm, int iFieldR, int iFieldC, simpleFunction<scalar> *k) :
helmholtzTerm<scalar>(gm, iFieldR, iFieldC, k, 0), ONE(0) {} helmholtzTerm<scalar>(gm, iFieldR, iFieldC, k, 0), ONE(0) {}
virtual ~laplaceTerm() virtual ~laplaceTerm()
{ {
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment