Changeset 16882
- Timestamp:
- 11/22/13 07:28:18 (11 years ago)
- Location:
- issm/trunk-jpl/src/c/analyses
- Files:
-
- 2 edited
Legend:
- Unmodified
- Added
- Removed
-
issm/trunk-jpl/src/c/analyses/StressbalanceAnalysis.cpp
r16874 r16882 980 980 981 981 /*Intermediaries*/ 982 bool mainlyfloating;982 bool mainlyfloating; 983 983 int migration_style,point1; 984 984 IssmDouble alpha2,Jdet,fraction1,fraction2; … … 1755 1755 if(element->IsFloating() || !element->IsOnBed()) return NULL; 1756 1756 1757 return NULL; 1757 /*Intermediaries*/ 1758 bool mainlyfloating; 1759 int migration_style,point1; 1760 IssmDouble alpha2,Jdet,fraction1,fraction2; 1761 IssmDouble gllevelset,phi=1.; 1762 IssmDouble *xyz_list_base = NULL; 1763 Gauss* gauss = NULL; 1764 1765 /*Fetch number of nodes and dof for this finite element*/ 1766 int numnodes = element->GetNumberOfNodes(); 1767 int numdof = numnodes*2; 1768 1769 /*Initialize Element matrix and vectors*/ 1770 ElementMatrix* Ke = element->NewElementMatrix(HOApproximationEnum); 1771 IssmDouble* B = xNew<IssmDouble>(2*numdof); 1772 IssmDouble D[2][2] = {0.}; 1773 1774 /*Retrieve all inputs and parameters*/ 1775 element->GetVerticesCoordinatesBase(&xyz_list_base); 1776 element->FindParam(&migration_style,GroundinglineMigrationEnum); 1777 Input* vx_input = element->GetInput(VxEnum); _assert_(vx_input); 1778 Input* vy_input = element->GetInput(VyEnum); _assert_(vy_input); 1779 Input* vz_input = element->GetInput(VzEnum); _assert_(vz_input); 1780 Input* gllevelset_input = NULL; 1781 1782 /*build friction object, used later on: */ 1783 Friction* friction=new Friction(element,2); 1784 1785 /*Recover portion of element that is grounded*/ 1786 if(migration_style==SubelementMigrationEnum) phi=element->GetGroundedPortion(xyz_list_base); 1787 if(migration_style==SubelementMigration2Enum){ 1788 gllevelset_input=element->GetInput(MaskGroundediceLevelsetEnum); _assert_(gllevelset_input); 1789 element->GetGroundedPart(&point1,&fraction1,&fraction2,&mainlyfloating); 1790 //gauss = element->NewGauss(point1,fraction1,fraction2,mainlyfloating,2); 1791 gauss=element->NewGaussBase(2); 1792 } 1793 else{ 1794 gauss=element->NewGaussBase(2); 1795 } 1796 1797 /* Start looping on the number of gaussian points: */ 1798 for(int ig=gauss->begin();ig<gauss->end();ig++){ 1799 gauss->GaussPoint(ig); 1800 1801 friction->GetAlpha2(&alpha2,gauss,vx_input,vy_input,vz_input); 1802 if(migration_style==SubelementMigrationEnum) alpha2=phi*alpha2; 1803 if(migration_style==SubelementMigration2Enum){ 1804 gllevelset_input->GetInputValue(&gllevelset, gauss); 1805 if(gllevelset<0.) alpha2=0.; 1806 } 1807 1808 this->GetBHOFriction(B,element,xyz_list_base,gauss); 1809 element->JacobianDeterminantBase(&Jdet,xyz_list_base,gauss); 1810 for(int i=0;i<2;i++) D[i][i]=alpha2*gauss->weight*Jdet; 1811 1812 TripleMultiply(B,2,numdof,1, 1813 &D[0][0],2,2,0, 1814 B,2,numdof,0, 1815 &Ke->values[0],1); 1816 } 1817 1818 /*Transform Coordinate System*/ 1819 element->TransformStiffnessMatrixCoord(Ke,XYEnum); 1820 1821 /*Clean up and return*/ 1822 delete gauss; 1823 delete friction; 1824 xDelete<IssmDouble>(xyz_list_base); 1825 xDelete<IssmDouble>(B); 1826 return Ke; 1758 1827 }/*}}}*/ 1759 1828 ElementVector* StressbalanceAnalysis::CreatePVectorHO(Element* element){/*{{{*/ … … 1950 2019 xDelete<IssmDouble>(dbasis); 1951 2020 }/*}}}*/ 2021 void StressbalanceAnalysis::GetBHOFriction(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss){/*{{{*/ 2022 /*Compute B matrix. B=[B1 B2 B3] where Bi is square and of size 2. 2023 * For node i, Bi can be expressed in the actual coordinate system 2024 * by: 2025 * Bi=[ N 0 ] 2026 * [ 0 N ] 2027 * where N is the finiteelement function for node i. 2028 * 2029 * We assume B has been allocated already, of size: 2 x (numdof*numnodes) 2030 */ 2031 2032 /*Fetch number of nodes for this finite element*/ 2033 int numnodes = element->GetNumberOfNodes(); 2034 2035 /*Get nodal functions derivatives*/ 2036 IssmDouble* basis=xNew<IssmDouble>(numnodes); 2037 element->NodalFunctions(basis,gauss); 2038 2039 /*Build L: */ 2040 for(int i=0;i<numnodes;i++){ 2041 B[2*numnodes*0+2*i+0] = basis[i]; 2042 B[2*numnodes*0+2*i+1] = 0.; 2043 B[2*numnodes*1+2*i+0] = 0.; 2044 B[2*numnodes*1+2*i+1] = basis[i]; 2045 } 2046 2047 /*Clean-up*/ 2048 xDelete<IssmDouble>(basis); 2049 }/*}}}*/ 1952 2050 void StressbalanceAnalysis::InputUpdateFromSolutionHO(IssmDouble* solution,Element* element){/*{{{*/ 1953 2051 … … 2108 2206 }/*}}}*/ 2109 2207 ElementMatrix* StressbalanceAnalysis::CreateKMatrixFSFriction(Element* element){/*{{{*/ 2110 return NULL; 2208 2209 if(element->IsFloating() || !element->IsOnBed()) return NULL; 2210 2211 /*If on water or not FS, skip stiffness: */ 2212 int approximation; 2213 element->GetInputValue(&approximation,ApproximationEnum); 2214 if(approximation!=FSApproximationEnum && approximation!=SSAFSApproximationEnum && approximation!=HOFSApproximationEnum) return NULL; 2215 2216 /*Intermediaries*/ 2217 bool mainlyfloating; 2218 int i,meshtype,dim,epssize; 2219 int migration_style,point1; 2220 IssmDouble alpha2,Jdet,fraction1,fraction2; 2221 IssmDouble gllevelset,phi=1.; 2222 IssmDouble *xyz_list_base = NULL; 2223 Gauss* gauss = NULL; 2224 2225 /*Get problem dimension*/ 2226 element->FindParam(&meshtype,MeshTypeEnum); 2227 switch(meshtype){ 2228 case Mesh2DverticalEnum: dim = 2;break; 2229 case Mesh3DEnum: dim = 3;break; 2230 default: _error_("mesh "<<EnumToStringx(meshtype)<<" not supported yet"); 2231 } 2232 2233 /*Fetch number of nodes and dof for this finite element*/ 2234 int vnumnodes = element->GetNumberOfNodesVelocity(); 2235 int pnumnodes = element->GetNumberOfNodesPressure(); 2236 int numdof = vnumnodes*dim + pnumnodes; 2237 2238 /*Initialize Element matrix and vectors*/ 2239 ElementMatrix* Ke = element->NewElementMatrix(FSvelocityEnum); 2240 IssmDouble* B = xNew<IssmDouble>((dim-1)*numdof); 2241 IssmDouble* D = xNewZeroInit<IssmDouble>((dim-1)*(dim-1)); 2242 2243 /*Retrieve all inputs and parameters*/ 2244 element->GetVerticesCoordinatesBase(&xyz_list_base); 2245 element->FindParam(&migration_style,GroundinglineMigrationEnum); 2246 Input* vx_input = element->GetInput(VxEnum); _assert_(vx_input); 2247 Input* vy_input = element->GetInput(VyEnum); _assert_(vy_input); 2248 Input* vz_input = NULL; 2249 if(dim==3){ vz_input = element->GetInput(VzEnum); _assert_(vz_input);} 2250 Input* gllevelset_input = NULL; 2251 2252 /*build friction object, used later on: */ 2253 Friction* friction=new Friction(element,dim==3?3:1); 2254 2255 /*Recover portion of element that is grounded*/ 2256 if(migration_style==SubelementMigrationEnum) phi=element->GetGroundedPortion(xyz_list_base); 2257 if(migration_style==SubelementMigration2Enum){ 2258 gllevelset_input=element->GetInput(MaskGroundediceLevelsetEnum); _assert_(gllevelset_input); 2259 element->GetGroundedPart(&point1,&fraction1,&fraction2,&mainlyfloating); 2260 //gauss = element->NewGauss(point1,fraction1,fraction2,mainlyfloating,2); 2261 gauss=element->NewGaussBase(3); 2262 } 2263 else{ 2264 gauss=element->NewGaussBase(3); 2265 } 2266 2267 /* Start looping on the number of gaussian points: */ 2268 for(int ig=gauss->begin();ig<gauss->end();ig++){ 2269 gauss->GaussPoint(ig); 2270 2271 friction->GetAlpha2(&alpha2,gauss,vx_input,vy_input,vz_input); 2272 if(migration_style==SubelementMigrationEnum) alpha2=phi*alpha2; 2273 if(migration_style==SubelementMigration2Enum){ 2274 gllevelset_input->GetInputValue(&gllevelset, gauss); 2275 if(gllevelset<0.) alpha2=0.; 2276 } 2277 2278 this->GetBFSFriction(B,element,dim,xyz_list_base,gauss); 2279 element->JacobianDeterminantBase(&Jdet,xyz_list_base,gauss); 2280 for(int i=0;i<2;i++) D[i*(dim-1)+i] = alpha2*gauss->weight*Jdet; //taub_x = -alpha2 v_x (same for y) 2281 2282 TripleMultiply(B,dim-1,numdof,1, 2283 D,dim-1,dim-1,0, 2284 B,dim-1,numdof,0, 2285 &Ke->values[0],1); 2286 } 2287 2288 /*DO NOT Transform Coordinate System: this stiffness matrix is already expressed in tangential coordinates*/ 2289 2290 /*Clean up and return*/ 2291 delete gauss; 2292 delete friction; 2293 xDelete<IssmDouble>(xyz_list_base); 2294 xDelete<IssmDouble>(B); 2295 xDelete<IssmDouble>(D); 2296 return Ke; 2111 2297 }/*}}}*/ 2112 2298 ElementVector* StressbalanceAnalysis::CreatePVectorFS(Element* element){/*{{{*/ … … 2575 2761 xDelete<IssmDouble>(pbasis); 2576 2762 }/*}}}*/ 2763 void StressbalanceAnalysis::GetBFSFriction(IssmDouble* B,Element* element,int dim,IssmDouble* xyz_list,Gauss* gauss){/*{{{*/ 2764 /* Compute L matrix. L=[L1 L2 L3] where Li is square and of size numdof. 2765 * For node i, Li can be expressed in the actual coordinate system 2766 * by in 3d 2767 * Li=[ h 0 0 0 ] 2768 * [ 0 h 0 0 ] 2769 * in 2d: 2770 * Li=[ h 0 0 ] 2771 * where h is the interpolation function for node i. 2772 */ 2773 2774 /*Fetch number of nodes for this finite element*/ 2775 int pnumnodes = element->GetNumberOfNodesPressure(); 2776 int vnumnodes = element->GetNumberOfNodesVelocity(); 2777 int pnumdof = pnumnodes; 2778 int vnumdof = vnumnodes*dim; 2779 2780 /*Get nodal functions derivatives*/ 2781 IssmDouble* vbasis=xNew<IssmDouble>(vnumnodes); 2782 element->NodalFunctionsVelocity(vbasis,gauss); 2783 2784 /*Build B: */ 2785 if(dim==3){ 2786 for(int i=0;i<vnumnodes;i++){ 2787 B[(vnumdof+pnumdof)*0+3*i+0] = vbasis[i]; 2788 B[(vnumdof+pnumdof)*0+3*i+1] = 0.; 2789 B[(vnumdof+pnumdof)*0+3*i+2] = 0.; 2790 2791 B[(vnumdof+pnumdof)*1+3*i+0] = 0.; 2792 B[(vnumdof+pnumdof)*1+3*i+1] = vbasis[i]; 2793 B[(vnumdof+pnumdof)*1+3*i+2] = 0.; 2794 } 2795 for(int i=0;i<pnumnodes;i++){ 2796 B[(vnumdof+pnumdof)*0+i+vnumdof+0] = 0.; 2797 B[(vnumdof+pnumdof)*1+i+vnumdof+0] = 0.; 2798 } 2799 } 2800 else{ 2801 for(int i=0;i<vnumnodes;i++){ 2802 B[2*i+0] = vbasis[i]; 2803 B[2*i+1] = 0.; 2804 } 2805 2806 for(int i=0;i<pnumnodes;i++){ 2807 B[i+vnumdof+0] = 0.; 2808 } 2809 } 2810 2811 /*Clean-up*/ 2812 xDelete<IssmDouble>(vbasis); 2813 }/*}}}*/ 2577 2814 void StressbalanceAnalysis::GetSolutionFromInputsFS(Vector<IssmDouble>* solution,Element* element){/*{{{*/ 2578 2815 -
issm/trunk-jpl/src/c/analyses/StressbalanceAnalysis.h
r16872 r16882 35 35 ElementVector* CreatePVectorSSAFront(Element* element); 36 36 void GetBSSA(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 37 void GetBSSAprime(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 37 38 void GetBSSAFriction(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 38 void GetBSSAprime(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss);39 39 void InputUpdateFromSolutionSSA(IssmDouble* solution,Element* element); 40 40 /*L1L2*/ … … 52 52 void GetBHO(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 53 53 void GetBHOprime(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 54 void GetBHOFriction(IssmDouble* B,Element* element,IssmDouble* xyz_list,Gauss* gauss); 54 55 void InputUpdateFromSolutionHO(IssmDouble* solution,Element* element); 55 56 /*FS*/ … … 63 64 void GetBFS(IssmDouble* B,Element* element,int dim,IssmDouble* xyz_list,Gauss* gauss); 64 65 void GetBFSprime(IssmDouble* B,Element* element,int dim,IssmDouble* xyz_list,Gauss* gauss); 66 void GetBFSFriction(IssmDouble* B,Element* element,int dim,IssmDouble* xyz_list,Gauss* gauss); 65 67 void GetSolutionFromInputsFS(Vector<IssmDouble>* solution,Element* element); 66 68 void InputUpdateFromSolutionFS(IssmDouble* solution,Element* element);
Note:
See TracChangeset
for help on using the changeset viewer.