Ice Sheet System Model  4.18
Code documentation
Public Member Functions | Data Fields | Private Attributes
Channel Class Reference

#include <Channel.h>

Inheritance diagram for Channel:
Load Object

Public Member Functions

 Channel ()
 
 Channel (int numericalflux_id, IssmDouble channelarea, int index, IoModel *iomodel)
 
 ~Channel ()
 
Objectcopy ()
 
void DeepEcho ()
 
void Echo ()
 
int Id ()
 
void Marshall (char **pmarshalled_data, int *pmarshalled_data_size, int marshall_direction)
 
int ObjectEnum ()
 
void InputUpdateFromConstant (IssmDouble constant, int name)
 
void InputUpdateFromConstant (int constant, int name)
 
void InputUpdateFromConstant (bool constant, int name)
 
void InputUpdateFromIoModel (int index, IoModel *iomodel)
 
void InputUpdateFromMatrixDakota (IssmDouble *matrix, int nrows, int ncols, int name, int type)
 
void InputUpdateFromVector (IssmDouble *vector, int name, int type)
 
void InputUpdateFromVectorDakota (IssmDouble *vector, int name, int type)
 
void Configure (Elements *elements, Loads *loads, Nodes *nodes, Vertices *vertices, Materials *materials, Parameters *parameters)
 
void CreateJacobianMatrix (Matrix< IssmDouble > *Jff)
 
void CreateKMatrix (Matrix< IssmDouble > *Kff, Matrix< IssmDouble > *Kfs)
 
void CreatePVector (Vector< IssmDouble > *pf)
 
void GetNodesLidList (int *lidlist)
 
void GetNodesSidList (int *sidlist)
 
int GetNumberOfNodes (void)
 
bool IsPenalty (void)
 
void PenaltyCreateJacobianMatrix (Matrix< IssmDouble > *Jff, IssmDouble kmax)
 
void PenaltyCreateKMatrix (Matrix< IssmDouble > *Kff, Matrix< IssmDouble > *kfs, IssmDouble kmax)
 
void PenaltyCreatePVector (Vector< IssmDouble > *pf, IssmDouble kmax)
 
void ResetHooks ()
 
void SetCurrentConfiguration (Elements *elements, Loads *loads, Nodes *nodes, Vertices *vertices, Materials *materials, Parameters *parameters)
 
void SetwiseNodeConnectivity (int *d_nz, int *o_nz, Node *node, bool *flags, int *flagsindices, int set1_enum, int set2_enum)
 
void SetChannelCrossSectionOld (void)
 
void UpdateChannelCrossSection (void)
 
ElementVectorCreatePVectorHydrologyGlaDS (void)
 
ElementMatrixCreateKMatrixHydrologyGlaDS (void)
 
void WriteChannelCrossSection (IssmPDouble *values)
 
- Public Member Functions inherited from Load
virtual ~Load ()
 
- Public Member Functions inherited from Object
virtual ~Object ()
 

Data Fields

int sid
 
int id
 
Hookhelement
 
Hookhnodes
 
Hookhvertices
 
Elementelement
 
Vertex ** vertices
 
Node ** nodes
 
Parametersparameters
 

Private Attributes

IssmDouble S
 
IssmDouble Sold
 
bool boundary
 

Detailed Description

Definition at line 18 of file Channel.h.

Constructor & Destructor Documentation

◆ Channel() [1/2]

Channel::Channel ( )

Definition at line 30 of file Channel.cpp.

30  {/*{{{*/
31  this->id = -1;
32  this->sid = -1;
33  this->parameters = NULL;
34  this->helement = NULL;
35  this->element = NULL;
36  this->hnodes = NULL;
37  this->hvertices = NULL;
38  this->nodes = NULL;
39 }

◆ Channel() [2/2]

Channel::Channel ( int  numericalflux_id,
IssmDouble  channelarea,
int  index,
IoModel iomodel 
)

Definition at line 41 of file Channel.cpp.

41  {/*{{{*/
42 //Channel::Channel(int channel_id,int i,int index,IoModel* iomodel)
43 
44  this->id=channel_id;
45  this->sid=channel_id-1;
46  this->parameters = NULL;
47  this->element = NULL;
48  this->nodes = NULL;
49 
50  /*Set channel cross section to 0*/
51  //this->S = 0.;
52  //this->Sold = 0.;
53  this->S = channelarea;
54  this->Sold = channelarea;
55 
56  /*Get edge info*/
57  int i1 = iomodel->faces[4*index+0];
58  int i2 = iomodel->faces[4*index+1];
59  int e1 = iomodel->faces[4*index+2];
60  int e2 = iomodel->faces[4*index+3];
61 
62  if(e2==-1){
63  this->boundary = true;
64  }
65  else{
66  this->boundary = false;
67  }
68 
69  /*Set Element hook (4th column may be -1 for boundary edges)*/
70  this->helement = new Hook(&e1,1);
71 
72  /*Set Vertices hooks (4th column may be -1 for boundary edges)*/
73  int channel_vertex_ids[2];
74  channel_vertex_ids[0]=i1;
75  channel_vertex_ids[1]=i2;
76  this->hvertices =new Hook(&channel_vertex_ids[0],2);
77 
78  /*Set Nodes hooks (!! Assumes P1 CG)*/
79  int channel_node_ids[2];
80  channel_node_ids[0]=i1;
81  channel_node_ids[1]=i2;
82  this->hnodes=new Hook(&channel_node_ids[0],2);
83 
84 }/*}}}*/

◆ ~Channel()

Channel::~Channel ( )

Definition at line 85 of file Channel.cpp.

85  {/*{{{*/
86  this->parameters=NULL;
87  delete helement;
88  delete hnodes;
89  delete hvertices;
90 }/*}}}*/

Member Function Documentation

◆ copy()

Object * Channel::copy ( void  )
virtual

Implements Object.

Definition at line 93 of file Channel.cpp.

93  {/*{{{*/
94 
95  Channel* channel=NULL;
96 
97  channel=new Channel();
98 
99  /*copy fields: */
100  channel->id=this->id;
101  channel->S=this->S;
102 
103  /*point parameters: */
104  channel->parameters=this->parameters;
105 
106  /*now deal with hooks and objects: */
107  channel->hnodes = (Hook*)this->hnodes->copy();
108  channel->hvertices = (Hook*)this->hvertices->copy();
109  channel->helement = (Hook*)this->helement->copy();
110 
111  /*corresponding fields*/
112  channel->nodes = (Node**)channel->hnodes->deliverp();
113  channel->vertices = (Vertex**)channel->hvertices->deliverp();
114  channel->element = (Element*)channel->helement->delivers();
115 
116  return channel;
117 }

◆ DeepEcho()

void Channel::DeepEcho ( void  )
virtual

Implements Object.

Definition at line 119 of file Channel.cpp.

119  {/*{{{*/
120 
121  _printf_("Channel:\n");
122  _printf_(" id: " << id << "\n");
123  _printf_(" S: " << S << "\n");
124  hnodes->DeepEcho();
125  hvertices->DeepEcho();
126  helement->DeepEcho();
127  _printf_(" parameters\n");
128  if(parameters)
129  parameters->DeepEcho();
130  else
131  _printf_(" NULL\n");
132 }

◆ Echo()

void Channel::Echo ( void  )
virtual

Implements Object.

Definition at line 134 of file Channel.cpp.

134  {/*{{{*/
135  _printf_("Channel:\n");
136  _printf_(" id: " << id << "\n");
137  _printf_(" S: " << S << "\n");
138  hnodes->Echo();
139  hvertices->Echo();
140  helement->Echo();
141  _printf_(" parameters: " << parameters << "\n");
142 }

◆ Id()

int Channel::Id ( void  )
virtual

Implements Object.

Definition at line 144 of file Channel.cpp.

144  {/*{{{*/
145  return id;
146 }

◆ Marshall()

void Channel::Marshall ( char **  pmarshalled_data,
int *  pmarshalled_data_size,
int  marshall_direction 
)
virtual

Implements Object.

Definition at line 148 of file Channel.cpp.

148  { /*{{{*/
149 
150  _assert_(this);
151 
152  /*ok, marshall operations: */
154  MARSHALLING(id);
155  MARSHALLING(S);
156 
157  if(marshall_direction==MARSHALLING_BACKWARD){
158  this->hnodes = new Hook();
159  this->hvertices = new Hook();
160  this->helement = new Hook();
161  }
162 
163  this->hnodes->Marshall(pmarshalled_data,pmarshalled_data_size,marshall_direction);
164  this->helement->Marshall(pmarshalled_data,pmarshalled_data_size,marshall_direction);
165  this->hvertices->Marshall(pmarshalled_data,pmarshalled_data_size,marshall_direction);
166 
167  /*corresponding fields*/
168  nodes =(Node**)this->hnodes->deliverp();
169  vertices =(Vertex**)this->hvertices->deliverp();
170  element =(Element*)this->helement->delivers();
171 
172 }

◆ ObjectEnum()

int Channel::ObjectEnum ( void  )
virtual

Implements Object.

Definition at line 174 of file Channel.cpp.

174  {/*{{{*/
175  return ChannelEnum;
176 }/*}}}*/

◆ InputUpdateFromConstant() [1/3]

void Channel::InputUpdateFromConstant ( IssmDouble  constant,
int  name 
)
inline

Definition at line 55 of file Channel.h.

55 {/*Do nothing*/};

◆ InputUpdateFromConstant() [2/3]

void Channel::InputUpdateFromConstant ( int  constant,
int  name 
)
inline

Definition at line 56 of file Channel.h.

56 {/*Do nothing*/};

◆ InputUpdateFromConstant() [3/3]

void Channel::InputUpdateFromConstant ( bool  constant,
int  name 
)
inline

Definition at line 57 of file Channel.h.

57 {_error_("Not implemented yet!");}

◆ InputUpdateFromIoModel()

void Channel::InputUpdateFromIoModel ( int  index,
IoModel iomodel 
)
inline

Definition at line 58 of file Channel.h.

58 {_error_("not implemented yet");};

◆ InputUpdateFromMatrixDakota()

void Channel::InputUpdateFromMatrixDakota ( IssmDouble matrix,
int  nrows,
int  ncols,
int  name,
int  type 
)
inline

Definition at line 59 of file Channel.h.

59 {/*Do nothing*/}

◆ InputUpdateFromVector()

void Channel::InputUpdateFromVector ( IssmDouble vector,
int  name,
int  type 
)
inline

Definition at line 60 of file Channel.h.

60 {/*Do nothing*/}

◆ InputUpdateFromVectorDakota()

void Channel::InputUpdateFromVectorDakota ( IssmDouble vector,
int  name,
int  type 
)
inline

Definition at line 61 of file Channel.h.

61 {/*Do nothing*/}

◆ Configure()

void Channel::Configure ( Elements elements,
Loads loads,
Nodes nodes,
Vertices vertices,
Materials materials,
Parameters parameters 
)
virtual

Implements Load.

Definition at line 179 of file Channel.cpp.

179  {/*{{{*/
180 
181  /*Take care of hooking up all objects for this element, ie links the objects in the hooks to their respective
182  * datasets, using internal ids and offsets hidden in hooks: */
183  hnodes->configure((DataSet*)nodesin);
184  hvertices->configure((DataSet*)verticesin);
185  helement->configure((DataSet*)elementsin);
186 
187  /*Initialize hooked fields*/
188  this->nodes = (Node**)hnodes->deliverp();
189  this->vertices = (Vertex**)hvertices->deliverp();
190  this->element = (Element*)helement->delivers();
191 
192  /*point parameters to real dataset: */
193  this->parameters=parametersin;
194 }

◆ CreateJacobianMatrix()

void Channel::CreateJacobianMatrix ( Matrix< IssmDouble > *  Jff)
inlinevirtual

Implements Load.

Definition at line 65 of file Channel.h.

65 {_error_("Not implemented yet");};

◆ CreateKMatrix()

void Channel::CreateKMatrix ( Matrix< IssmDouble > *  Kff,
Matrix< IssmDouble > *  Kfs 
)
virtual

Implements Load.

Definition at line 196 of file Channel.cpp.

196  {/*{{{*/
197 
198  /*recover some parameters*/
199  ElementMatrix* Ke=NULL;
200  int analysis_type;
201  this->parameters->FindParam(&analysis_type,AnalysisTypeEnum);
202 
203  switch(analysis_type){
205  Ke = this->CreateKMatrixHydrologyGlaDS();
206  break;
207  default:
208  _error_("Don't know why we should be here");
209  }
210 
211  /*Add to global matrix*/
212  if(Ke){
213  Ke->AddToGlobal(Kff,Kfs);
214  delete Ke;
215  }
216 
217 }

◆ CreatePVector()

void Channel::CreatePVector ( Vector< IssmDouble > *  pf)
virtual

Implements Load.

Definition at line 219 of file Channel.cpp.

219  {/*{{{*/
220 
221  /*recover some parameters*/
222  ElementVector* pe=NULL;
223  int analysis_type;
224  this->parameters->FindParam(&analysis_type,AnalysisTypeEnum);
225 
226  switch(analysis_type){
228  pe = this->CreatePVectorHydrologyGlaDS();
229  break;
230  default:
231  _error_("Don't know why we should be here");
232  }
233 
234  /*Add to global matrix*/
235  if(pe){
236  pe->AddToGlobal(pf);
237  delete pe;
238  }
239 
240 }

◆ GetNodesLidList()

void Channel::GetNodesLidList ( int *  lidlist)
virtual

Implements Load.

Definition at line 242 of file Channel.cpp.

242  {/*{{{*/
243 
244  _assert_(lidlist);
245  _assert_(nodes);
246 
247  for(int i=0;i<NUMNODES;i++) lidlist[i]=nodes[i]->Lid();
248 }

◆ GetNodesSidList()

void Channel::GetNodesSidList ( int *  sidlist)
virtual

Implements Load.

Definition at line 250 of file Channel.cpp.

250  {/*{{{*/
251 
252  _assert_(sidlist);
253  _assert_(nodes);
254 
255  for(int i=0;i<NUMNODES;i++) sidlist[i]=nodes[i]->Sid();
256 }

◆ GetNumberOfNodes()

int Channel::GetNumberOfNodes ( void  )
virtual

Implements Load.

Definition at line 258 of file Channel.cpp.

258  {/*{{{*/
259  return NUMNODES;
260 }

◆ IsPenalty()

bool Channel::IsPenalty ( void  )
virtual

Implements Load.

Definition at line 262 of file Channel.cpp.

262  {/*{{{*/
263  return false;
264 }

◆ PenaltyCreateJacobianMatrix()

void Channel::PenaltyCreateJacobianMatrix ( Matrix< IssmDouble > *  Jff,
IssmDouble  kmax 
)
inlinevirtual

Implements Load.

Definition at line 72 of file Channel.h.

72 {_error_("Not implemented yet");};

◆ PenaltyCreateKMatrix()

void Channel::PenaltyCreateKMatrix ( Matrix< IssmDouble > *  Kff,
Matrix< IssmDouble > *  kfs,
IssmDouble  kmax 
)
virtual

Implements Load.

Definition at line 266 of file Channel.cpp.

266  {/*{{{*/
267 
268  /*No stiffness loads applied, do nothing: */
269  return;
270 
271 }

◆ PenaltyCreatePVector()

void Channel::PenaltyCreatePVector ( Vector< IssmDouble > *  pf,
IssmDouble  kmax 
)
virtual

Implements Load.

Definition at line 273 of file Channel.cpp.

273  {/*{{{*/
274 
275  /*No penalty loads applied, do nothing: */
276  return;
277 
278 }

◆ ResetHooks()

void Channel::ResetHooks ( )
virtual

Implements Load.

Definition at line 280 of file Channel.cpp.

280  {/*{{{*/
281 
282  this->nodes=NULL;
283  this->vertices=NULL;
284  this->element=NULL;
285  this->parameters=NULL;
286 
287  /*Get Element type*/
288  this->hnodes->reset();
289  this->hvertices->reset();
290  this->helement->reset();
291 
292 }

◆ SetCurrentConfiguration()

void Channel::SetCurrentConfiguration ( Elements elements,
Loads loads,
Nodes nodes,
Vertices vertices,
Materials materials,
Parameters parameters 
)
virtual

Implements Load.

Definition at line 294 of file Channel.cpp.

294  {/*{{{*/
295 
296 }

◆ SetwiseNodeConnectivity()

void Channel::SetwiseNodeConnectivity ( int *  d_nz,
int *  o_nz,
Node node,
bool *  flags,
int *  flagsindices,
int  set1_enum,
int  set2_enum 
)
virtual

Implements Load.

Definition at line 298 of file Channel.cpp.

298  {/*{{{*/
299 
300  /*Output */
301  int d_nz = 0;
302  int o_nz = 0;
303 
304  /*Loop over all nodes*/
305  for(int i=0;i<this->GetNumberOfNodes();i++){
306 
307  if(!flags[this->nodes[i]->Lid()]){
308 
309  /*flag current node so that no other element processes it*/
310  flags[this->nodes[i]->Lid()]=true;
311 
312  int counter=0;
313  while(flagsindices[counter]>=0) counter++;
314  flagsindices[counter]=this->nodes[i]->Lid();
315 
316  /*if node is clone, we have an off-diagonal non-zero, else it is a diagonal non-zero*/
317  switch(set2_enum){
318  case FsetEnum:
319  if(nodes[i]->fsize){
320  if(this->nodes[i]->IsClone())
321  o_nz += 1;
322  else
323  d_nz += 1;
324  }
325  break;
326  case GsetEnum:
327  if(nodes[i]->gsize){
328  if(this->nodes[i]->IsClone())
329  o_nz += 1;
330  else
331  d_nz += 1;
332  }
333  break;
334  case SsetEnum:
335  if(nodes[i]->ssize){
336  if(this->nodes[i]->IsClone())
337  o_nz += 1;
338  else
339  d_nz += 1;
340  }
341  break;
342  default: _error_("not supported");
343  }
344  }
345  }
346 
347  /*Assign output pointers: */
348  *pd_nz=d_nz;
349  *po_nz=o_nz;
350 }

◆ SetChannelCrossSectionOld()

void Channel::SetChannelCrossSectionOld ( void  )

Definition at line 596 of file Channel.cpp.

596  {/*{{{*/
597 
598  this->Sold = this->S;
599 
600 } /*}}}*/

◆ UpdateChannelCrossSection()

void Channel::UpdateChannelCrossSection ( void  )

Definition at line 601 of file Channel.cpp.

601  {/*{{{*/
602 
603  /*Initialize Element matrix and return if necessary*/
604  Tria* tria=(Tria*)element;
605  if(!tria->IsIceInElement() || this->boundary){
606  this->S = 0.;
607  return;
608  }
609  _assert_(tria->FiniteElement()==P1Enum);
610  int index1=tria->GetVertexIndex(vertices[0]);
611  int index2=tria->GetVertexIndex(vertices[1]);
612 
613  /*Intermediaries */
614  IssmDouble A,B,n,phi,phi_0,ks,Ngrad;
615  IssmDouble H,h,b,dphi[2],dphids,dphimds,db[2],dbds;
616  IssmDouble xyz_list[NUMVERTICES][3];
617  IssmDouble xyz_list_tria[3][3];
618 
619  /*Retrieve all inputs and parameters*/
620  GetVerticesCoordinates(&xyz_list[0][0] ,this->vertices,NUMVERTICES);
621  GetVerticesCoordinates(&xyz_list_tria[0][0],tria->vertices,3);
622 
631 
633  Input2* H_input = element->GetInput2(ThicknessEnum); _assert_(H_input);
634  Input2* b_input = element->GetInput2(BedEnum); _assert_(b_input);
635  Input2* B_input = element->GetInput2(MaterialsRheologyBEnum); _assert_(B_input);
636  Input2* n_input = element->GetInput2(MaterialsRheologyNEnum); _assert_(n_input);
638  Input2* phi_input = element->GetInput2(HydraulicPotentialEnum); _assert_(phi_input);
639 
640  /*Get tangent vector*/
641  IssmDouble tx = xyz_list_tria[index2][0] - xyz_list_tria[index1][0];
642  IssmDouble ty = xyz_list_tria[index2][1] - xyz_list_tria[index1][1];
643  IssmDouble Lt = sqrt(tx*tx+ty*ty);
644  tx = tx/Lt;
645  ty = ty/Lt;
646 
647  /*Evaluate fields on center of edge*/
648  GaussTria* gauss=new GaussTria();
649  gauss->GaussEdgeCenter(index1,index2);
650 
651  /*Get input values at gauss points*/
652  phi_input->GetInputValue(&phi,gauss);
653  phi_input->GetInputDerivativeValue(&dphi[0],&xyz_list_tria[0][0],gauss);
654  h_input->GetInputValue(&h,gauss);
655  ks_input->GetInputValue(&ks,gauss);
656  B_input->GetInputValue(&B,gauss);
657  n_input->GetInputValue(&n,gauss);
658  b_input->GetInputValue(&b,gauss);
659  b_input->GetInputDerivativeValue(&db[0],&xyz_list_tria[0][0],gauss);
660  H_input->GetInputValue(&H,gauss);
661 
662  /*Get values for a few potentials*/
663  phi_0 = rho_water*g*b + rho_ice*g*H;
664  dphids = dphi[0]*tx + dphi[1]*ty;
665  dphimds = rho_water*g*(db[0]*tx + db[1]*ty);
666  Ngrad = fabs(dphids);
667  if(Ngrad<AEPS) Ngrad = AEPS;
668 
669  /*d(phi - phi_m)/ds*/
670  IssmDouble dPw = dphids - dphimds;
671 
672  /*Approx. discharge in the sheet flowing folwing in the direction of the channel ofver a width lc*/
673  IssmDouble qc = - ks * pow(h,ALPHA_S) * pow(Ngrad,BETA_S-2.) * dphids;
674 
675  /*Ice rate factor*/
676  A=pow(B,-n);
677 
678  IssmDouble C = C_W*c_t*rho_water;
679  IssmDouble Qprime = -kc * pow(Ngrad,BETA_C-2.)*dphids;
680  IssmDouble N = phi_0 - phi;
681 
682  bool converged = false;
683  int count = 0;
684 
685  while(!converged){
686 
687  IssmDouble Snew = this->S;
688 
689  /*Compute f factor*/
690  IssmDouble fFactor = 0.;
691  if(this->S>0. || qc*dPw>0.){
692  fFactor = lc * qc;
693  }
694 
695  IssmDouble alpha = 1./(rho_ice*L)*(
696  fabs(Qprime*pow(Snew,ALPHA_C-1.)*dphids)
697  + C*Qprime*pow(Snew,ALPHA_C-1.)*dPw
698  ) - 2./pow(n,n)*A*pow(fabs(N),n-1.)*N;
699 
700  IssmDouble beta = 1./(rho_ice*L)*( fabs(lc*qc*dphids) + C*fFactor*dPw );
701 
702  /*Solve ODE*/
703  this->S = ODE1(alpha,beta,this->Sold,dt,2);
704  if(this->S<0.) this->S = 0.;
705  _assert_(!xIsNan<IssmDouble>(this->S));
706 
707  count++;
708 
709  if(fabs((this->S - Snew)/(Snew+AEPS))<1e-8 || count>=10) converged = true;
710  }
711 
712  /*Clean up and return*/
713  delete gauss;
714 }

◆ CreatePVectorHydrologyGlaDS()

ElementVector * Channel::CreatePVectorHydrologyGlaDS ( void  )

Definition at line 487 of file Channel.cpp.

487  {/*{{{*/
488 
489  /*Initialize Element matrix and return if necessary*/
490  Tria* tria=(Tria*)element;
491  if(!tria->IsIceInElement()) return NULL;
492  _assert_(tria->FiniteElement()==P1Enum);
493  int index1=tria->GetVertexIndex(vertices[0]);
494  int index2=tria->GetVertexIndex(vertices[1]);
495 
496  /*Intermediaries */
497  IssmDouble Jdet,v2,Afactor,Bfactor,fFactor;
498  IssmDouble A,B,n,phi_old,phi,phi_0,dphimds,dphi[2];
499  IssmDouble H,h,b,db[2],dphids,qc,dPw,ks,Ngrad;
500  IssmDouble xyz_list[NUMVERTICES][3];
501  IssmDouble xyz_list_tria[3][3];
502  const int numnodes = NUMNODES;
503 
504  /*Initialize Element vector and other vectors*/
505  ElementVector* pe = new ElementVector(this->nodes,NUMNODES,this->parameters);
506  IssmDouble basis[NUMNODES];
507 
508  /*Retrieve all inputs and parameters*/
509  GetVerticesCoordinates(&xyz_list[0][0],this->vertices,NUMVERTICES);
510  GetVerticesCoordinates(&xyz_list_tria[0][0],tria->vertices,3);
511 
519 
521  Input2* H_input = element->GetInput2(ThicknessEnum); _assert_(H_input);
522  Input2* b_input = element->GetInput2(BedEnum); _assert_(b_input);
523  Input2* B_input = element->GetInput2(MaterialsRheologyBEnum); _assert_(B_input);
524  Input2* n_input = element->GetInput2(MaterialsRheologyNEnum); _assert_(n_input);
526  Input2* phi_input = element->GetInput2(HydraulicPotentialEnum); _assert_(phi_input);
527 
528  /*Get tangent vector*/
529  IssmDouble tx = xyz_list_tria[index2][0] - xyz_list_tria[index1][0];
530  IssmDouble ty = xyz_list_tria[index2][1] - xyz_list_tria[index1][1];
531  IssmDouble Lt = sqrt(tx*tx+ty*ty);
532  tx = tx/Lt;
533  ty = ty/Lt;
534 
535  /* Start looping on the number of gaussian points: */
536  Gauss* gauss=new GaussTria(index1,index2,2);
537  for(int ig=gauss->begin();ig<gauss->end();ig++){
538  gauss->GaussPoint(ig);
539 
540  tria->GetSegmentJacobianDeterminant(&Jdet,&xyz_list[0][0],gauss);
541  tria->GetSegmentNodalFunctions(&basis[0],gauss,index1,index2,tria->FiniteElement());
542 
543  /*Get input values at gauss points*/
544  b_input->GetInputDerivativeValue(&db[0],&xyz_list_tria[0][0],gauss);
545  phi_input->GetInputDerivativeValue(&dphi[0],&xyz_list_tria[0][0],gauss);
546  h_input->GetInputValue(&h,gauss);
547  ks_input->GetInputValue(&ks,gauss);
548  B_input->GetInputValue(&B,gauss);
549  n_input->GetInputValue(&n,gauss);
550  phi_input->GetInputValue(&phi,gauss);
551  b_input->GetInputValue(&b,gauss);
552  H_input->GetInputValue(&H,gauss);
553 
554  /*Get values for a few potentials*/
555  phi_0 = rho_water*g*b + rho_ice*g*H;
556  dphids = dphi[0]*tx + dphi[1]*ty;
557  dphimds = rho_water*g*(db[0]*tx + db[1]*ty);
558  Ngrad = fabs(dphids);
559  if(Ngrad<AEPS) Ngrad = AEPS;
560 
561  /*Compute the effective conductivity Ks = k h^alpha |grad Phi|^{beta-2} (same for sheet)*/
562  IssmDouble Ks = ks * pow(h,ALPHA_S) * pow(Ngrad,BETA_S-2.);
563 
564  /*Approx. discharge in the sheet flowing folwing in the direction of the channel ofver a width lc*/
565  qc = - Ks * dphids;
566 
567  /*d(phi - phi_m)/ds*/
568  dPw = dphids - dphimds;
569 
570  /*Compute f factor*/
571  fFactor = 0.;
572  if(this->S>0. || qc*dPw>0.){
573  fFactor = lc * qc;
574  }
575 
576  /*Compute Afactor and Bfactor*/
577  Afactor = C_W*c_t*rho_water;
578  Bfactor = 1./L * (1./rho_ice - 1./rho_water);
579 
580  /*Compute closing rate*/
581  /*See Gagliardini and Werder 2018 eq. A2 (v = v2(phi_i) + v1*phi_{i+1})*/
582  A=pow(B,-n);
583  v2 = 2./pow(n,n)*A*this->S*(pow(fabs(phi_0 - phi),n-1.)*(phi_0 +(n-1.)*phi));
584 
585  for(int i=0;i<numnodes;i++){
586  pe->values[i]+= - Jdet*gauss->weight*(-v2)*basis[i];
587  pe->values[i]+= + Jdet*gauss->weight*Afactor*Bfactor*fFactor*dphimds*basis[i];
588  }
589  }
590 
591  /*Clean up and return*/
592  delete gauss;
593  return pe;
594 }

◆ CreateKMatrixHydrologyGlaDS()

ElementMatrix * Channel::CreateKMatrixHydrologyGlaDS ( void  )

Definition at line 354 of file Channel.cpp.

354  {/*{{{*/
355 
356  /*Initialize Element matrix and return if necessary*/
357  Tria* tria=(Tria*)element;
358  if(!tria->IsIceInElement()) return NULL;
359  _assert_(tria->FiniteElement()==P1Enum);
360  int index1=tria->GetVertexIndex(vertices[0]);
361  int index2=tria->GetVertexIndex(vertices[1]);
362 
363  /*Intermediaries */
364  IssmDouble Jdet,v1,qc,fFactor,Afactor,Bfactor,Xifactor;
365  IssmDouble A,B,n,phi_old,phi,phi_0,dPw,ks,Ngrad;
366  IssmDouble H,h,b,dphi[2],dphids,dphimds,db[2],dbds;
367  IssmDouble xyz_list[NUMVERTICES][3];
368  IssmDouble xyz_list_tria[3][3];
369  const int numnodes = NUMNODES;
370 
371  /*Initialize Element vector and other vectors*/
372  ElementMatrix* Ke=new ElementMatrix(this->nodes,NUMNODES,this->parameters);
373  IssmDouble basis[NUMNODES];
374  IssmDouble dbasisdx[2*NUMNODES];
375  IssmDouble dbasisds[NUMNODES];
376 
377  /*Retrieve all inputs and parameters*/
378  GetVerticesCoordinates(&xyz_list[0][0] ,this->vertices,NUMVERTICES);
379  GetVerticesCoordinates(&xyz_list_tria[0][0],tria->vertices,3);
380 
388 
390  Input2* H_input = element->GetInput2(ThicknessEnum); _assert_(H_input);
391  Input2* b_input = element->GetInput2(BedEnum); _assert_(b_input);
392  Input2* B_input = element->GetInput2(MaterialsRheologyBEnum); _assert_(B_input);
393  Input2* n_input = element->GetInput2(MaterialsRheologyNEnum); _assert_(n_input);
395  Input2* phi_input = element->GetInput2(HydraulicPotentialEnum); _assert_(phi_input);
396 
397  /*Get tangent vector*/
398  IssmDouble tx = xyz_list_tria[index2][0] - xyz_list_tria[index1][0];
399  IssmDouble ty = xyz_list_tria[index2][1] - xyz_list_tria[index1][1];
400  IssmDouble Lt = sqrt(tx*tx+ty*ty);
401  tx = tx/Lt;
402  ty = ty/Lt;
403 
404  /* Start looping on the number of gaussian points: */
405  Gauss* gauss=new GaussTria(index1,index2,2);
406  for(int ig=gauss->begin();ig<gauss->end();ig++){
407  gauss->GaussPoint(ig);
408 
409  tria->GetSegmentJacobianDeterminant(&Jdet,&xyz_list[0][0],gauss);
410  tria->GetSegmentNodalFunctions(&basis[0],gauss,index1,index2,tria->FiniteElement());
411  tria->GetSegmentNodalFunctionsDerivatives(&dbasisdx[0],&xyz_list_tria[0][0],gauss,index1,index2,tria->FiniteElement());
412  dbasisds[0] = dbasisdx[0*2+0]*tx + dbasisdx[0*2+1]*ty;
413  dbasisds[1] = dbasisdx[1*2+0]*tx + dbasisdx[1*2+1]*ty;
414 
415  /*Get input values at gauss points*/
416  phi_input->GetInputDerivativeValue(&dphi[0],&xyz_list_tria[0][0],gauss);
417  b_input->GetInputDerivativeValue(&db[0],&xyz_list_tria[0][0],gauss);
418  phi_input->GetInputValue(&phi,gauss);
419  h_input->GetInputValue(&h,gauss);
420  ks_input->GetInputValue(&ks,gauss);
421  B_input->GetInputValue(&B,gauss);
422  n_input->GetInputValue(&n,gauss);
423  b_input->GetInputValue(&b,gauss);
424  H_input->GetInputValue(&H,gauss);
425 
426  /*Get values for a few potentials*/
427  phi_0 = rho_water*g*b + rho_ice*g*H;
428  dphids = dphi[0]*tx + dphi[1]*ty;
429  dphimds = rho_water*g*(db[0]*tx + db[1]*ty);
430  Ngrad = fabs(dphids);
431  if(Ngrad<AEPS) Ngrad = AEPS;
432 
433  /*Compute the effective conductivity Kc = k h^alpha |grad Phi|^{beta-2} (same for sheet)*/
434  IssmDouble Kc = kc * pow(this->S,ALPHA_C) * pow(Ngrad,BETA_C-2.);
435  IssmDouble Ks = ks * pow(h ,ALPHA_S) * pow(Ngrad,BETA_S-2.);
436 
437  /*Approx. discharge in the sheet flowing folwing in the direction of the channel ofver a width lc*/
438  qc = - Ks * dphids;
439 
440  /*d(phi - phi_m)/ds*/
441  dPw = dphids - dphimds;
442 
443  /*Compute f factor*/
444  fFactor = 0.;
445  if(this->S>0. || qc*dPw>0.){
446  fFactor = lc * qc;
447  }
448 
449  /*Compute Afactor and Bfactor*/
450  Afactor = C_W*c_t*rho_water;
451  Bfactor = 1./L * (1./rho_ice - 1./rho_water);
452  if(dphids>0){
453  Xifactor = + Bfactor * (fabs(-Kc*dphids) + fabs(lc*qc));
454  }
455  else{
456  Xifactor = - Bfactor * (fabs(-Kc*dphids) + fabs(lc*qc));
457  }
458 
459  /*Diffusive term*/
460  for(int i=0;i<numnodes;i++){
461  for(int j=0;j<numnodes;j++){
462  /*GlaDSCoupledSolver.F90 line 1659*/
463  Ke->values[i*numnodes+j] += gauss->weight*Jdet*(
464  +Kc*dbasisds[i]*dbasisds[j] /*Diffusion term*/
465  - Afactor * Bfactor* Kc * dPw * basis[i] * dbasisds[j] /*First part of Pi*/
466  + Afactor * fFactor * Bfactor * basis[i] * dbasisds[j] /*Second part of Pi*/
467  + Xifactor* basis[i] * dbasisds[j] /*Xi term*/
468  );
469  }
470  }
471 
472  /*Closing rate term, see Gagliardini and Werder 2018 eq. A2 (v = v1*phi_i + v2(phi_{i+1}))*/
473  A=pow(B,-n);
474  v1 = 2./pow(n,n)*A*S*(pow(fabs(phi_0 - phi),n-1.)*( - n));
475  for(int i=0;i<numnodes;i++){
476  for(int j=0;j<numnodes;j++){
477  Ke->values[i*numnodes+j] += gauss->weight*Jdet*(-v1)*basis[i]*basis[j];
478  }
479  }
480  }
481 
482  /*Clean up and return*/
483  delete gauss;
484  return Ke;
485 }

◆ WriteChannelCrossSection()

void Channel::WriteChannelCrossSection ( IssmPDouble values)

Definition at line 716 of file Channel.cpp.

716  {/*{{{*/
717 
718  _assert_(values);
719  values[this->sid] = reCast<IssmPDouble>(this->S);
720 }

Field Documentation

◆ S

IssmDouble Channel::S
private

Definition at line 21 of file Channel.h.

◆ Sold

IssmDouble Channel::Sold
private

Definition at line 22 of file Channel.h.

◆ boundary

bool Channel::boundary
private

Definition at line 23 of file Channel.h.

◆ sid

int Channel::sid

Definition at line 26 of file Channel.h.

◆ id

int Channel::id

Definition at line 27 of file Channel.h.

◆ helement

Hook* Channel::helement

Definition at line 30 of file Channel.h.

◆ hnodes

Hook* Channel::hnodes

Definition at line 31 of file Channel.h.

◆ hvertices

Hook* Channel::hvertices

Definition at line 32 of file Channel.h.

◆ element

Element* Channel::element

Definition at line 35 of file Channel.h.

◆ vertices

Vertex** Channel::vertices

Definition at line 36 of file Channel.h.

◆ nodes

Node** Channel::nodes

Definition at line 37 of file Channel.h.

◆ parameters

Parameters* Channel::parameters

Definition at line 38 of file Channel.h.


The documentation for this class was generated from the following files:
Channel::GetNumberOfNodes
int GetNumberOfNodes(void)
Definition: Channel.cpp:258
BETA_C
#define BETA_C
Definition: Channel.cpp:23
Channel
Definition: Channel.h:18
_assert_
#define _assert_(ignore)
Definition: exceptions.h:37
IssmDouble
double IssmDouble
Definition: types.h:37
Element::FindParam
void FindParam(bool *pvalue, int paramenum)
Definition: Element.cpp:933
Channel::CreatePVectorHydrologyGlaDS
ElementVector * CreatePVectorHydrologyGlaDS(void)
Definition: Channel.cpp:487
TriaRef::GetSegmentJacobianDeterminant
void GetSegmentJacobianDeterminant(IssmDouble *Jdet, IssmDouble *xyz_list, Gauss *gauss)
Definition: TriaRef.cpp:229
Channel::hvertices
Hook * hvertices
Definition: Channel.h:32
_printf_
#define _printf_(StreamArgs)
Definition: Print.h:22
Channel::hnodes
Hook * hnodes
Definition: Channel.h:31
HydraulicPotentialEnum
@ HydraulicPotentialEnum
Definition: EnumDefinitions.h:597
Channel::CreateKMatrixHydrologyGlaDS
ElementMatrix * CreateKMatrixHydrologyGlaDS(void)
Definition: Channel.cpp:354
Hook::deliverp
Object ** deliverp(void)
Definition: Hook.cpp:187
Channel::S
IssmDouble S
Definition: Channel.h:21
MaterialsRhoFreshwaterEnum
@ MaterialsRhoFreshwaterEnum
Definition: EnumDefinitions.h:263
MARSHALLING_ENUM
#define MARSHALLING_ENUM(EN)
Definition: Marshalling.h:14
TimesteppingTimeStepEnum
@ TimesteppingTimeStepEnum
Definition: EnumDefinitions.h:433
Hook::DeepEcho
void DeepEcho(void)
Definition: Hook.cpp:77
BedEnum
@ BedEnum
Definition: EnumDefinitions.h:499
Channel::id
int id
Definition: Channel.h:27
Channel::Sold
IssmDouble Sold
Definition: Channel.h:22
HydrologyPressureMeltCoefficientEnum
@ HydrologyPressureMeltCoefficientEnum
Definition: EnumDefinitions.h:171
SsetEnum
@ SsetEnum
Definition: EnumDefinitions.h:1282
ALPHA_S
#define ALPHA_S
Definition: Channel.cpp:25
MaterialsLatentheatEnum
@ MaterialsLatentheatEnum
Definition: EnumDefinitions.h:254
MaterialsRhoIceEnum
@ MaterialsRhoIceEnum
Definition: EnumDefinitions.h:264
ElementVector::values
IssmDouble * values
Definition: ElementVector.h:24
Element::vertices
Vertex ** vertices
Definition: Element.h:49
Channel::Channel
Channel()
Definition: Channel.cpp:30
MaterialsRheologyNEnum
@ MaterialsRheologyNEnum
Definition: EnumDefinitions.h:651
BETA_S
#define BETA_S
Definition: Channel.cpp:26
TriaRef::GetSegmentNodalFunctions
void GetSegmentNodalFunctions(IssmDouble *basis, Gauss *gauss, int index1, int index2, int finiteelement)
Definition: TriaRef.cpp:243
Hook::reset
void reset(void)
Definition: Hook.cpp:211
Input2::GetInputDerivativeValue
virtual void GetInputDerivativeValue(IssmDouble *derivativevalues, IssmDouble *xyz_list, Gauss *gauss)
Definition: Input2.h:37
Element::GetInput2
virtual Input2 * GetInput2(int inputenum)=0
HydrologyGlaDSAnalysisEnum
@ HydrologyGlaDSAnalysisEnum
Definition: EnumDefinitions.h:1100
Element
Definition: Element.h:41
Channel::element
Element * element
Definition: Channel.h:35
P1Enum
@ P1Enum
Definition: EnumDefinitions.h:662
Channel::vertices
Vertex ** vertices
Definition: Channel.h:36
GaussTria
Definition: GaussTria.h:12
ChannelEnum
@ ChannelEnum
Definition: EnumDefinitions.h:1008
HydrologySheetConductivityEnum
@ HydrologySheetConductivityEnum
Definition: EnumDefinitions.h:620
Parameters::DeepEcho
void DeepEcho()
Definition: Parameters.cpp:99
ConstantsGEnum
@ ConstantsGEnum
Definition: EnumDefinitions.h:102
Hook::delivers
Object * delivers(void)
Definition: Hook.cpp:191
HydrologySheetThicknessEnum
@ HydrologySheetThicknessEnum
Definition: EnumDefinitions.h:621
Hook
Definition: Hook.h:16
Hook::configure
void configure(DataSet *dataset)
Definition: Hook.cpp:145
GsetEnum
@ GsetEnum
Definition: EnumDefinitions.h:1093
Channel::sid
int sid
Definition: Channel.h:26
Channel::boundary
bool boundary
Definition: Channel.h:23
alpha
IssmDouble alpha(IssmDouble x, IssmDouble y, IssmDouble z, int testid)
Definition: fsanalyticals.cpp:221
MARSHALLING
#define MARSHALLING(FIELD)
Definition: Marshalling.h:29
GetVerticesCoordinates
void GetVerticesCoordinates(IssmDouble *xyz, Vertex **vertices, int numvertices, bool spherical)
Definition: Vertex.cpp:225
C_W
#define C_W
Definition: Channel.cpp:21
Tria::FiniteElement
int FiniteElement(void)
Definition: Tria.cpp:1318
Hook::copy
Object * copy(void)
Definition: Hook.cpp:61
Input2
Definition: Input2.h:18
MARSHALLING_BACKWARD
@ MARSHALLING_BACKWARD
Definition: Marshalling.h:10
NUMVERTICES
#define NUMVERTICES
Definition: Channel.cpp:19
Element::IsIceInElement
bool IsIceInElement()
Definition: Element.cpp:2021
ODE1
IssmDouble ODE1(IssmDouble alpha, IssmDouble beta, IssmDouble Si, IssmDouble dt, int method)
Definition: ODE1.cpp:5
Node
Definition: Node.h:23
Node::Lid
int Lid(void)
Definition: Node.cpp:618
_error_
#define _error_(StreamArgs)
Definition: exceptions.h:49
Tria
Definition: Tria.h:29
NUMNODES
#define NUMNODES
Definition: Channel.cpp:18
HydrologyChannelConductivityEnum
@ HydrologyChannelConductivityEnum
Definition: EnumDefinitions.h:164
MaterialsRheologyBEnum
@ MaterialsRheologyBEnum
Definition: EnumDefinitions.h:643
IoModel::faces
int * faces
Definition: IoModel.h:88
Channel::parameters
Parameters * parameters
Definition: Channel.h:38
Gauss::begin
virtual int begin(void)=0
ALPHA_C
#define ALPHA_C
Definition: Channel.cpp:22
HydrologyChannelSheetWidthEnum
@ HydrologyChannelSheetWidthEnum
Definition: EnumDefinitions.h:165
TriaRef::GetSegmentNodalFunctionsDerivatives
void GetSegmentNodalFunctionsDerivatives(IssmDouble *dbasis, IssmDouble *xyz_list_tria, Gauss *gauss, int index1, int index2, int finiteelement)
Definition: TriaRef.cpp:286
Gauss::GaussPoint
virtual void GaussPoint(int ig)=0
GaussTria::GaussEdgeCenter
void GaussEdgeCenter(int index1, int index2)
Definition: GaussTria.cpp:423
Parameters::FindParam
void FindParam(bool *pinteger, int enum_type)
Definition: Parameters.cpp:262
ThicknessEnum
@ ThicknessEnum
Definition: EnumDefinitions.h:840
ElementVector::AddToGlobal
void AddToGlobal(Vector< IssmDouble > *pf)
Definition: ElementVector.cpp:155
AnalysisTypeEnum
@ AnalysisTypeEnum
Definition: EnumDefinitions.h:36
Channel::helement
Hook * helement
Definition: Channel.h:30
ElementVector
Definition: ElementVector.h:20
ElementMatrix::AddToGlobal
void AddToGlobal(Matrix< IssmDouble > *Kff, Matrix< IssmDouble > *Kfs)
Definition: ElementMatrix.cpp:271
Hook::Echo
void Echo(void)
Definition: Hook.cpp:104
Input2::GetInputValue
virtual void GetInputValue(IssmDouble *pvalue, Gauss *gauss)
Definition: Input2.h:38
Vertex
Definition: Vertex.h:19
Gauss::weight
IssmDouble weight
Definition: Gauss.h:11
FsetEnum
@ FsetEnum
Definition: EnumDefinitions.h:1075
DataSet
Declaration of DataSet class.
Definition: DataSet.h:14
ElementMatrix
Definition: ElementMatrix.h:19
Channel::nodes
Node ** nodes
Definition: Channel.h:37
Gauss
Definition: Gauss.h:8
Tria::GetVertexIndex
int GetVertexIndex(Vertex *vertex)
Definition: Tria.cpp:2368
AEPS
#define AEPS
Definition: Channel.cpp:27
Hook::Marshall
void Marshall(char **pmarshalled_data, int *pmarshalled_data_size, int marshall_direction)
Definition: Hook.cpp:122
ElementMatrix::values
IssmDouble * values
Definition: ElementMatrix.h:26