Changeset 15731
- Timestamp:
- 08/06/13 16:02:26 (12 years ago)
- Location:
- issm/trunk-jpl/src/c/classes/Elements
- Files:
-
- 2 edited
Legend:
- Unmodified
- Added
- Removed
-
issm/trunk-jpl/src/c/classes/Elements/Tria.cpp
r15728 r15731 270 270 /*Fetch number of nodes and dof for this finite element*/ 271 271 int numnodes = this->NumberofNodes(); 272 int numdof = numnodes*NDOF1;273 272 274 273 /*Initialize Element matrix and vectors*/ … … 289 288 D=gauss->weight*Jdet; 290 289 291 TripleMultiply(basis,1,num dof,1,290 TripleMultiply(basis,1,numnodes,1, 292 291 &D,1,1,0, 293 basis,1,num dof,0,292 basis,1,numnodes,0, 294 293 &Ke->values[0],1); 295 294 } … … 1583 1582 break; 1584 1583 case AdjointBalancethicknessAnalysisEnum: 1585 InputUpdateFromSolution AdjointBalancethickness(solution);1584 InputUpdateFromSolutionOneDof(solution,AdjointEnum); 1586 1585 break; 1587 1586 #endif … … 1625 1624 void Tria::InputUpdateFromSolutionOneDof(IssmDouble* solution,int enum_type){ 1626 1625 1627 const int numdof = NDOF1*NUMVERTICES; 1628 int* doflist = NULL; 1629 IssmDouble values[numdof]; 1630 1631 /*Get dof list: */ 1626 /*Intermediary*/ 1627 int* doflist = NULL; 1628 1629 /*Fetch number of nodes for this finite element*/ 1630 int numnodes = this->NumberofNodes(); 1631 1632 /*Fetch dof list and allocate solution vector*/ 1632 1633 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 1634 IssmDouble* values = xNew<IssmDouble>(numnodes); 1633 1635 1634 1636 /*Use the dof list to index into the solution vector: */ 1635 for(int i=0;i<num dof;i++){1637 for(int i=0;i<numnodes;i++){ 1636 1638 values[i]=solution[doflist[i]]; 1637 1639 if(xIsNan<IssmDouble>(values[i])) _error_("NaN found in solution vector"); … … 1642 1644 1643 1645 /*Free ressources:*/ 1646 xDelete<IssmDouble>(values); 1644 1647 xDelete<int>(doflist); 1645 1648 } … … 1649 1652 1650 1653 /*Intermediaries*/ 1651 const int numdof = NDOF1*NUMVERTICES; 1652 1653 int i,hydroadjustment; 1654 int* doflist=NULL; 1655 IssmDouble rho_ice,rho_water,minthickness; 1656 IssmDouble newthickness[numdof]; 1657 IssmDouble newbed[numdof]; 1658 IssmDouble newsurface[numdof]; 1659 IssmDouble oldbed[NUMVERTICES]; 1660 IssmDouble oldsurface[NUMVERTICES]; 1661 IssmDouble oldthickness[NUMVERTICES]; 1662 1663 /*Get dof list: */ 1654 int i,hydroadjustment; 1655 int* doflist=NULL; 1656 IssmDouble rho_ice,rho_water,minthickness; 1657 1658 /*Fetch number of nodes for this finite element*/ 1659 int numnodes = this->NumberofNodes(); 1660 1661 /*Fetch dof list and allocate solution vector*/ 1664 1662 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 1663 IssmDouble* newthickness = xNew<IssmDouble>(numnodes); 1664 IssmDouble* newbed = xNew<IssmDouble>(numnodes); 1665 IssmDouble* newsurface = xNew<IssmDouble>(numnodes); 1666 IssmDouble* oldthickness = xNew<IssmDouble>(numnodes); 1667 IssmDouble* oldbed = xNew<IssmDouble>(numnodes); 1668 IssmDouble* oldsurface = xNew<IssmDouble>(numnodes); 1665 1669 1666 1670 /*Use the dof list to index into the solution vector: */ 1667 1671 this->parameters->FindParam(&minthickness,PrognosticMinThicknessEnum); 1668 for(i=0;i<num dof;i++){1672 for(i=0;i<numnodes;i++){ 1669 1673 newthickness[i]=solution[doflist[i]]; 1670 1674 if(xIsNan<IssmDouble>(newthickness[i])) _error_("NaN found in solution vector"); … … 1674 1678 1675 1679 /*Get previous bed, thickness and surface*/ 1676 GetInputListOn Vertices(&oldbed[0],BedEnum);1677 GetInputListOn Vertices(&oldsurface[0],SurfaceEnum);1678 GetInputListOn Vertices(&oldthickness[0],ThicknessEnum);1680 GetInputListOnNodes(&oldbed[0],BedEnum); 1681 GetInputListOnNodes(&oldsurface[0],SurfaceEnum); 1682 GetInputListOnNodes(&oldthickness[0],ThicknessEnum); 1679 1683 1680 1684 /*Fing PrognosticHydrostaticAdjustment to figure out how to update the geometry:*/ … … 1683 1687 rho_water=matpar->GetRhoWater(); 1684 1688 1685 for(i=0;i<num dof;i++) {1689 for(i=0;i<numnodes;i++) { 1686 1690 /*If shelf: hydrostatic equilibrium*/ 1687 1691 if (this->nodes[i]->IsGrounded()){ 1688 newsurface[i] =oldbed[i]+newthickness[i]; //surface = oldbed + newthickness1689 newbed[i] =oldbed[i];//same bed: do nothing1692 newsurface[i] = oldbed[i]+newthickness[i]; //surface = oldbed + newthickness 1693 newbed[i] = oldbed[i]; //same bed: do nothing 1690 1694 } 1691 1695 else{ //this is an ice shelf 1692 1693 1696 if(hydroadjustment==AbsoluteEnum){ 1694 newsurface[i] =newthickness[i]*(1-rho_ice/rho_water);1695 newbed[i] =newthickness[i]*(-rho_ice/rho_water);1697 newsurface[i] = newthickness[i]*(1-rho_ice/rho_water); 1698 newbed[i] = newthickness[i]*(-rho_ice/rho_water); 1696 1699 } 1697 1700 else if(hydroadjustment==IncrementalEnum){ 1698 newsurface[i] =oldsurface[i]+(1.0-rho_ice/rho_water)*(newthickness[i]-oldthickness[i]); //surface = oldsurface + (1-di) * dH1699 newbed[i] =oldbed[i]-rho_ice/rho_water*(newthickness[i]-oldthickness[i]); //bed= oldbed + di * dH1701 newsurface[i] = oldsurface[i]+(1.0-rho_ice/rho_water)*(newthickness[i]-oldthickness[i]); //surface = oldsurface + (1-di) * dH 1702 newbed[i] = oldbed[i]-rho_ice/rho_water*(newthickness[i]-oldthickness[i]); //bed = oldbed + di * dH 1700 1703 } 1701 1704 else _error_("Hydrostatic adjustment " << hydroadjustment << " (" << EnumToStringx(hydroadjustment) << ") not supported yet"); … … 1709 1712 1710 1713 /*Free ressources:*/ 1714 xDelete<IssmDouble>(newthickness); 1715 xDelete<IssmDouble>(newbed); 1716 xDelete<IssmDouble>(newsurface); 1717 xDelete<IssmDouble>(oldthickness); 1718 xDelete<IssmDouble>(oldbed); 1719 xDelete<IssmDouble>(oldsurface); 1711 1720 xDelete<int>(doflist); 1712 1721 } … … 1715 1724 void Tria::InputUpdateFromVector(IssmDouble* vector, int name, int type){ 1716 1725 1717 const int num dof = NDOF1 *NUMVERTICES;1718 int *doflist 1719 IssmDouble values[num dof];1726 const int numnodes = NUMVERTICES; 1727 int *doflist = NULL; 1728 IssmDouble values[numnodes]; 1720 1729 1721 1730 /*Check that name is an element input*/ … … 1750 1759 1751 1760 case NodesEnum: 1761 _assert_(this->element_type==P1Enum); 1752 1762 /*Get dof list: */ 1753 1763 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 1754 1764 1755 1765 /*Use the dof list to index into the vector: */ 1756 for(int i=0;i<num dof;i++){1766 for(int i=0;i<numnodes;i++){ 1757 1767 values[i]=vector[doflist[i]]; 1758 1768 if(xIsNan<IssmDouble>(values[i])) _error_("NaN found in solution vector"); … … 1766 1776 1767 1777 case NodeSIdEnum: 1778 _assert_(this->element_type==P1Enum); 1768 1779 for(int i=0;i<NUMVERTICES;i++){ 1769 1780 values[i]=vector[nodes[i]->Sid()]; … … 1772 1783 /*Add input to the element: */ 1773 1784 this->inputs->AddInput(new TriaInput(name,values,P1Enum)); 1774 1775 /*Free ressources:*/1776 xDelete<int>(doflist);1777 1785 return; 1778 1786 … … 2567 2575 IssmDouble Tria::MassFlux( IssmDouble* segment){ 2568 2576 2569 const int numdofs=2;2570 2577 int dim; 2571 IssmDouble mass_flux=0 ;2578 IssmDouble mass_flux=0.; 2572 2579 IssmDouble xyz_list[NUMVERTICES][3]; 2573 2580 IssmDouble normal[2]; … … 5019 5026 /*Fetch number of nodes and dof for this finite element*/ 5020 5027 int numnodes = this->NumberofNodes(); 5021 int numdof = numnodes*NDOF2;5022 5028 5023 5029 /*Initialize Element vector*/ … … 5255 5261 ElementMatrix* Tria::CreateKMatrixAdjointSSA(void){ 5256 5262 5257 /*Constants*/5258 const int numnodes = this->NumberofNodes();5259 const int numdof = NDOF2*numnodes;5260 5261 5263 /*Intermediaries */ 5262 5264 int i,j; … … 5271 5273 GaussTria *gauss=NULL; 5272 5274 5275 /*Fetch number of nodes and dof for this finite element*/ 5276 int numnodes = this->NumberofNodes(); 5277 5273 5278 /*Initialize Jacobian with regular SSA (first part of the Gateau derivative)*/ 5274 5279 parameters->FindParam(&incomplete_adjoint,InversionIncompleteAdjointEnum); … … 5328 5333 void Tria::InputUpdateFromSolutionAdjointHoriz(IssmDouble* solution){ 5329 5334 5330 const int numdof=NDOF2*NUMVERTICES; 5331 5332 int i; 5333 int* doflist=NULL; 5334 IssmDouble values[numdof]; 5335 IssmDouble lambdax[NUMVERTICES]; 5336 IssmDouble lambday[NUMVERTICES]; 5337 5338 /*Get dof list: */ 5335 int i; 5336 int* doflist=NULL; 5337 5338 /*Fetch number of nodes and dof for this finite element*/ 5339 int numnodes = this->NumberofNodes(); 5340 int numdof = numnodes*NDOF2; 5341 5342 /*Fetch dof list and allocate solution vectors*/ 5339 5343 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 5344 IssmDouble* values = xNew<IssmDouble>(numdof); 5345 IssmDouble* lambdax = xNew<IssmDouble>(numnodes); 5346 IssmDouble* lambday = xNew<IssmDouble>(numnodes); 5340 5347 5341 5348 /*Use the dof list to index into the solution vector: */ 5342 5349 for(i=0;i<numdof;i++) values[i]=solution[doflist[i]]; 5343 5350 5351 /*Transform solution in Cartesian Space*/ 5352 TransformSolutionCoord(&values[0],nodes,numnodes,XYEnum); 5353 5344 5354 /*Ok, we have vx and vy in values, fill in vx and vy arrays: */ 5345 for(i=0;i< NUMVERTICES;i++){5355 for(i=0;i<numdof;i++){ 5346 5356 lambdax[i]=values[i*NDOF2+0]; 5347 5357 lambday[i]=values[i*NDOF2+1]; … … 5357 5367 5358 5368 /*Free ressources:*/ 5359 xDelete<int>(doflist); 5360 } 5361 /*}}}*/ 5362 /*FUNCTION Tria::InputUpdateFromSolutionAdjointBalancethickness {{{*/ 5363 void Tria::InputUpdateFromSolutionAdjointBalancethickness(IssmDouble* solution){ 5364 5365 const int numdof=NDOF1*NUMVERTICES; 5366 5367 int i; 5368 int* doflist=NULL; 5369 IssmDouble values[numdof]; 5370 IssmDouble lambda[NUMVERTICES]; 5371 5372 /*Get dof list: */ 5373 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 5374 5375 /*Use the dof list to index into the solution vector: */ 5376 for(i=0;i<numdof;i++) values[i]=solution[doflist[i]]; 5377 5378 /*Ok, we have vx and vy in values, fill in vx and vy arrays: */ 5379 for(i=0;i<numdof;i++){ 5380 lambda[i]=values[i]; 5381 if(xIsNan<IssmDouble>(lambda[i])) _error_("NaN found in solution vector"); 5382 } 5383 5384 /*Add vx and vy as inputs to the tria element: */ 5385 this->inputs->AddInput(new TriaInput(AdjointEnum,lambda,P1Enum)); 5386 5387 /*Free ressources:*/ 5369 xDelete<IssmDouble>(values); 5370 xDelete<IssmDouble>(lambdax); 5371 xDelete<IssmDouble>(lambday); 5388 5372 xDelete<int>(doflist); 5389 5373 } … … 5464 5448 /*Fetch number of nodes and dof for this finite element*/ 5465 5449 int numnodes = this->NumberofNodes(); 5466 int numdof = numnodes*NDOF1;5467 5450 5468 5451 /*Initialize Element vector and vectors*/ 5469 5452 ElementMatrix* Ke=new ElementMatrix(nodes,numnodes,this->parameters,NoneApproximationEnum); 5470 5453 IssmDouble* basis = xNew<IssmDouble>(numnodes); 5471 5472 /*Initialize Element matrix*/5473 5454 5474 5455 /*Retrieve all inputs and parameters*/ … … 5488 5469 D_scalar=latentheat/heatcapacity*gauss->weight*Jdet; 5489 5470 5490 TripleMultiply(basis,num dof,1,0,5471 TripleMultiply(basis,numnodes,1,0, 5491 5472 &D_scalar,1,1,0, 5492 basis,1,num dof,0,5473 basis,1,numnodes,0, 5493 5474 &Ke->values[0],1); 5494 5475 } … … 5691 5672 /*Fetch number of nodes and dof for this finite element*/ 5692 5673 int numnodes = this->NumberofNodes(); 5693 int numdof = numnodes*NDOF1;5694 5674 5695 5675 /*Initialize Element matrix and vectors*/ 5696 5676 ElementMatrix* Ke = new ElementMatrix(nodes,numnodes,this->parameters); 5697 IssmDouble* B = xNew<IssmDouble>(5*num dof);5677 IssmDouble* B = xNew<IssmDouble>(5*numnodes); 5698 5678 IssmDouble* basis = xNew<IssmDouble>(numnodes); 5699 5679 IssmDouble D[2][2]; … … 5719 5699 D[1][0]=0.; D[1][1]=D_scalar; 5720 5700 GetBHydro(B,&xyz_list[0][0],gauss); 5721 TripleMultiply(B,2,num dof,1,5701 TripleMultiply(B,2,numnodes,1, 5722 5702 &D[0][0],2,2,0, 5723 B,2,num dof,0,5703 B,2,numnodes,0, 5724 5704 &Ke->values[0],1); 5725 5705 … … 5729 5709 D_scalar=sediment_storing*gauss->weight*Jdet; 5730 5710 5731 TripleMultiply(basis,num dof,1,0,5711 TripleMultiply(basis,numnodes,1,0, 5732 5712 &D_scalar,1,1,0, 5733 basis,1,num dof,0,5713 basis,1,numnodes,0, 5734 5714 &Ke->values[0],1); 5735 5715 } … … 5758 5738 /*Fetch number of nodes and dof for this finite element*/ 5759 5739 int numnodes = this->NumberofNodes(); 5760 int numdof = numnodes*NDOF1;5761 5740 5762 5741 /*Initialize Element matrix and vectors*/ 5763 5742 ElementMatrix* Ke = new ElementMatrix(nodes,numnodes,this->parameters); 5764 IssmDouble* B = xNew<IssmDouble>(5*num dof);5743 IssmDouble* B = xNew<IssmDouble>(5*numnodes); 5765 5744 IssmDouble* basis = xNew<IssmDouble>(numnodes); 5766 5745 IssmDouble D[2][2]; … … 5785 5764 D[1][0]=0.; D[1][1]=D_scalar; 5786 5765 GetBHydro(B,&xyz_list[0][0],gauss); 5787 TripleMultiply(B,2,num dof,1,5766 TripleMultiply(B,2,numnodes,1, 5788 5767 &D[0][0],2,2,0, 5789 B,2,num dof,0,5768 B,2,numnodes,0, 5790 5769 &Ke->values[0],1); 5791 5770 … … 5795 5774 D_scalar=epl_storing*gauss->weight*Jdet; 5796 5775 5797 TripleMultiply(basis,num dof,1,0,5776 TripleMultiply(basis,numnodes,1,0, 5798 5777 &D_scalar,1,1,0, 5799 basis,1,num dof,0,5778 basis,1,numnodes,0, 5800 5779 &Ke->values[0],1); 5801 5780 } … … 5824 5803 /*Fetch number of nodes and dof for this finite element*/ 5825 5804 int numnodes = this->NumberofNodes(); 5826 int numdof = numnodes*NDOF1;5827 5805 5828 5806 /*Initialize Element vector*/ … … 5850 5828 5851 5829 if(reCast<int,IssmDouble>(dt)){ 5852 for(i=0;i<num dof;i++) pe->values[i]+=Jdettria*gauss->weight*(old_watercolumn_g+dt*basal_melting_g)*basis[i];5830 for(i=0;i<numnodes;i++) pe->values[i]+=Jdettria*gauss->weight*(old_watercolumn_g+dt*basal_melting_g)*basis[i]; 5853 5831 } 5854 5832 else{ 5855 for(i=0;i<num dof;i++) pe->values[i]+=Jdettria*gauss->weight*basal_melting_g*basis[i];5833 for(i=0;i<numnodes;i++) pe->values[i]+=Jdettria*gauss->weight*basal_melting_g*basis[i]; 5856 5834 } 5857 5835 } … … 5999 5977 void Tria::GetSolutionFromInputsOneDof(Vector<IssmDouble>* solution, int enum_type){ 6000 5978 6001 const int numdof=NDOF1*NUMVERTICES;6002 6003 int i;6004 5979 int *doflist = NULL; 6005 IssmDouble enum_value; 6006 IssmDouble values[numdof]; 6007 GaussTria *gauss = NULL; 6008 6009 /*Get dof list: */ 5980 IssmDouble value; 5981 5982 /*Fetch number of nodes for this finite element*/ 5983 int numnodes = this->NumberofNodes(); 5984 5985 /*Fetch dof list and allocate solution vector*/ 6010 5986 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 5987 IssmDouble* values = xNew<IssmDouble>(numnodes); 6011 5988 6012 5989 /*Get inputs*/ … … 6014 5991 6015 5992 /*Ok, we have the values, fill in the array: */ 6016 /*P1 element only for now*/ 6017 gauss=new GaussTria(); 6018 for(i=0;i<NUMVERTICES;i++){ 6019 6020 gauss->GaussVertex(i); 6021 6022 /*Recover dof values*/ 6023 enum_input->GetInputValue(&enum_value,gauss); 6024 values[i]=enum_value; 6025 } 6026 6027 solution->SetValues(numdof,doflist,values,INS_VAL); 5993 GaussTria* gauss=new GaussTria(); 5994 for(int i=0;i<numnodes;i++){ 5995 gauss->GaussNode(this->element_type,i); 5996 5997 enum_input->GetInputValue(&value,gauss); 5998 values[i]=value; 5999 } 6000 6001 solution->SetValues(numnodes,doflist,values,INS_VAL); 6028 6002 6029 6003 /*Free ressources:*/ 6004 xDelete<int>(doflist); 6005 xDelete<IssmDouble>(values); 6030 6006 delete gauss; 6031 xDelete<int>(doflist);6032 6007 } 6033 6008 /*}}}*/ … … 6035 6010 void Tria::InputUpdateFromSolutionHydrologyShreve(IssmDouble* solution){ 6036 6011 6037 /*Intermediaries*/ 6038 const int numdof = NDOF1 *NUMVERTICES; 6039 int *doflist = NULL; 6040 IssmDouble values[numdof]; 6041 6042 /*Get dof list: */ 6012 /*Intermediary*/ 6013 int* doflist = NULL; 6014 6015 /*Fetch number of nodes for this finite element*/ 6016 int numnodes = this->NumberofNodes(); 6017 6018 /*Fetch dof list and allocate solution vector*/ 6043 6019 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 6020 IssmDouble* values = xNew<IssmDouble>(numnodes); 6044 6021 6045 6022 /*Use the dof list to index into the solution vector: */ 6046 for(int i=0;i<num dof;i++){6023 for(int i=0;i<numnodes;i++){ 6047 6024 values[i]=solution[doflist[i]]; 6048 6025 if(xIsNan<IssmDouble>(values[i])) _error_("NaN found in solution vector"); … … 6054 6031 6055 6032 /*Free ressources:*/ 6033 xDelete<IssmDouble>(values); 6056 6034 xDelete<int>(doflist); 6057 6035 } … … 6061 6039 6062 6040 /*Intermediaries*/ 6063 const int numdof = NDOF1 *NUMVERTICES;6064 6041 int *doflist = NULL; 6065 6042 bool converged; 6066 IssmDouble values[numdof];6067 IssmDouble residual[numdof];6068 6043 IssmDouble penalty_factor, dt; 6069 6044 IssmDouble kmax, kappa, h_max; 6070 6045 6071 /*Get dof list: */ 6046 /*Fetch number of nodes for this finite element*/ 6047 int numnodes = this->NumberofNodes(); 6048 6049 /*Fetch dof list and allocate solution vector*/ 6072 6050 GetDofList(&doflist,NoneApproximationEnum,GsetEnum); 6051 IssmDouble* values = xNew<IssmDouble>(numnodes); 6052 IssmDouble* residual = xNew<IssmDouble>(numnodes); 6073 6053 6074 6054 /*Use the dof list to index into the solution vector: */ 6075 for(int i=0;i<num dof;i++){6055 for(int i=0;i<numnodes;i++){ 6076 6056 values[i]=solution[doflist[i]]; 6077 6057 if(xIsNan<IssmDouble>(values[i])) _error_("NaN found in solution vector"); … … 6088 6068 kappa=kmax*pow(10.,penalty_factor); 6089 6069 6090 for(int i=0;i< NUMVERTICES;i++){6070 for(int i=0;i<numnodes;i++){ 6091 6071 this->GetHydrologyDCInefficientHmax(&h_max,nodes[i]); 6092 6072 if(values[i]>h_max){ … … 6104 6084 6105 6085 /*Free ressources:*/ 6086 xDelete<IssmDouble>(values); 6087 xDelete<IssmDouble>(residual); 6106 6088 xDelete<int>(doflist); 6107 6089 } … … 6145 6127 void Tria::GetHydrologyTransfer(Vector<IssmDouble>* transfer){ 6146 6128 6147 const int numdof 6148 int *doflist 6129 const int numdof = NDOF1 *NUMVERTICES; 6130 int *doflist = NULL; 6149 6131 bool isefficientlayer; 6150 6132 int transfermethod; -
issm/trunk-jpl/src/c/classes/Elements/Tria.h
r15718 r15731 242 242 ElementVector* CreatePVectorAdjointHoriz(void); 243 243 ElementVector* CreatePVectorAdjointBalancethickness(void); 244 void InputUpdateFromSolutionAdjointBalancethickness( IssmDouble* solution); 245 void InputUpdateFromSolutionAdjointHoriz( IssmDouble* solution); 244 void InputUpdateFromSolutionAdjointHoriz( IssmDouble* solution); 246 245 #endif 247 246
Note:
See TracChangeset
for help on using the changeset viewer.