Changeset 15713
- Timestamp:
- 08/05/13 16:17:37 (12 years ago)
- File:
-
- 1 edited
Legend:
- Unmodified
- Added
- Removed
-
issm/trunk-jpl/src/c/classes/Elements/Tria.cpp
r15712 r15713 407 407 ElementVector* Tria::CreatePVectorSlope(void){ 408 408 409 /*Constants*/410 const int numdof=NDOF1*NUMVERTICES;411 412 409 /*Intermediaries */ 413 int i; 414 int analysis_type; 410 int i,analysis_type; 415 411 IssmDouble Jdet; 416 412 IssmDouble xyz_list[NUMVERTICES][3]; 417 413 IssmDouble slope[2]; 418 IssmDouble basis[3]; 419 GaussTria* gauss=NULL; 414 415 /*Fetch number of nodes and dof for this finite element*/ 416 int numnodes = this->NumberofNodes(); 420 417 421 418 /*Initialize Element vector*/ 422 ElementVector* pe=new ElementVector(nodes,NUMVERTICES,this->parameters); 419 ElementVector* pe = new ElementVector(nodes,numnodes,this->parameters); 420 IssmDouble* basis = xNew<IssmDouble>(numnodes); 423 421 424 422 /*Retrieve all inputs and parameters*/ … … 434 432 435 433 /* Start looping on the number of gaussian points: */ 436 gauss=new GaussTria(2);434 GaussTria* gauss=new GaussTria(2); 437 435 for(int ig=gauss->begin();ig<gauss->end();ig++){ 438 436 … … 440 438 441 439 GetJacobianDeterminant(&Jdet, &xyz_list[0][0],gauss); 442 GetNodalFunctions(basis, 440 GetNodalFunctions(basis,gauss); 443 441 444 442 slope_input->GetInputDerivativeValue(&slope[0],&xyz_list[0][0],gauss); 445 443 446 if 447 for(i=0;i<num dof;i++) pe->values[i]+=Jdet*gauss->weight*slope[0]*basis[i];448 } 449 if 450 for(i=0;i<num dof;i++) pe->values[i]+=Jdet*gauss->weight*slope[1]*basis[i];444 if( (analysis_type==SurfaceSlopeXAnalysisEnum) || (analysis_type==BedSlopeXAnalysisEnum)){ 445 for(i=0;i<numnodes;i++) pe->values[i]+=Jdet*gauss->weight*slope[0]*basis[i]; 446 } 447 if( (analysis_type==SurfaceSlopeYAnalysisEnum) || (analysis_type==BedSlopeYAnalysisEnum)){ 448 for(i=0;i<numnodes;i++) pe->values[i]+=Jdet*gauss->weight*slope[1]*basis[i]; 451 449 } 452 450 } 453 451 454 452 /*Clean up and return*/ 453 xDelete<IssmDouble>(basis); 455 454 delete gauss; 456 455 return pe; … … 3157 3156 /*Initialize Element vector and vectors*/ 3158 3157 ElementVector* pe=new ElementVector(nodes,numnodes,this->parameters,SSAApproximationEnum); 3159 GaussTria* gauss = new GaussTria(2);3160 3158 IssmDouble* basis = xNew<IssmDouble>(numnodes); 3161 3159 … … 3168 3166 3169 3167 /* Start looping on the number of gaussian points: */ 3168 GaussTria* gauss = new GaussTria(2); 3170 3169 for(int ig=gauss->begin();ig<gauss->end();ig++){ 3171 3170 … … 4917 4916 ElementVector* Tria::CreatePVectorAdjointBalancethickness(void){ 4918 4917 4919 /*Constants*/4920 const int numdof=1*NUMVERTICES;4921 4922 4918 /*Intermediaries */ 4923 int i,resp; 4924 IssmDouble Jdet; 4925 IssmDouble thickness,thicknessobs,weight; 4926 int num_responses; 4927 IssmDouble xyz_list[NUMVERTICES][3]; 4928 IssmDouble basis[3]; 4929 IssmDouble dbasis[NDOF2][NUMVERTICES]; 4930 IssmDouble dH[2]; 4931 IssmDouble vx,vy,vel; 4932 GaussTria *gauss = NULL; 4919 int i,resp; 4920 IssmDouble Jdet; 4921 IssmDouble thickness,thicknessobs,weight; 4922 int num_responses; 4923 IssmDouble xyz_list[NUMVERTICES][3]; 4924 IssmDouble dH[2]; 4925 IssmDouble vx,vy,vel; 4933 4926 int *responses = NULL; 4934 4927 4935 /*Initialize Element vector*/ 4936 ElementVector* pe=new ElementVector(nodes,NUMVERTICES,this->parameters); 4928 /*Fetch number of nodes and dof for this finite element*/ 4929 int numnodes = this->NumberofNodes(); 4930 4931 /*Initialize Element vector and vectors*/ 4932 ElementVector* pe = new ElementVector(nodes,numnodes,this->parameters); 4933 IssmDouble* basis = xNew<IssmDouble>(numnodes); 4934 IssmDouble* dbasis = xNew<IssmDouble>(2*numnodes); 4937 4935 4938 4936 /*Retrieve all inputs and parameters*/ … … 4947 4945 4948 4946 /* Start looping on the number of gaussian points: */ 4949 gauss=new GaussTria(2);4947 GaussTria* gauss=new GaussTria(2); 4950 4948 for(int ig=gauss->begin();ig<gauss->end();ig++){ 4951 4949 … … 4954 4952 GetJacobianDeterminant(&Jdet, &xyz_list[0][0],gauss); 4955 4953 GetNodalFunctions(basis, gauss); 4956 GetNodalFunctionsDerivatives( &dbasis[0][0],&xyz_list[0][0],gauss);4954 GetNodalFunctionsDerivatives(dbasis,&xyz_list[0][0],gauss); 4957 4955 4958 4956 thickness_input->GetInputValue(&thickness, gauss); … … 4965 4963 case ThicknessAbsMisfitEnum: 4966 4964 weights_input->GetInputValue(&weight, gauss,resp); 4967 for(i=0;i<num dof;i++) pe->values[i]+=(thicknessobs-thickness)*weight*Jdet*gauss->weight*basis[i];4965 for(i=0;i<numnodes;i++) pe->values[i]+=(thicknessobs-thickness)*weight*Jdet*gauss->weight*basis[i]; 4968 4966 break; 4969 4967 case ThicknessAbsGradientEnum: 4970 4968 weights_input->GetInputValue(&weight, gauss,resp); 4971 for(i=0;i<num dof;i++) pe->values[i]+= - weight*dH[0]*dbasis[0][i]*Jdet*gauss->weight;4972 for(i=0;i<num dof;i++) pe->values[i]+= - weight*dH[1]*dbasis[1][i]*Jdet*gauss->weight;4969 for(i=0;i<numnodes;i++) pe->values[i]+= - weight*dH[0]*dbasis[0*numnodes+i]*Jdet*gauss->weight; 4970 for(i=0;i<numnodes;i++) pe->values[i]+= - weight*dH[1]*dbasis[1*numnodes+i]*Jdet*gauss->weight; 4973 4971 break; 4974 4972 case ThicknessAlongGradientEnum: … … 4979 4977 vx = vx/(vel+1.e-9); 4980 4978 vy = vy/(vel+1.e-9); 4981 for(i=0;i<num dof;i++) pe->values[i]+= - weight*(dH[0]*vx+dH[1]*vy)*(dbasis[0][i]*vx+dbasis[1][i]*vy)*Jdet*gauss->weight;4979 for(i=0;i<numnodes;i++) pe->values[i]+= - weight*(dH[0]*vx+dH[1]*vy)*(dbasis[0*numnodes+i]*vx+dbasis[1*numnodes+i]*vy)*Jdet*gauss->weight; 4982 4980 break; 4983 4981 case ThicknessAcrossGradientEnum: … … 4988 4986 vx = vx/(vel+1.e-9); 4989 4987 vy = vy/(vel+1.e-9); 4990 for(i=0;i<num dof;i++) pe->values[i]+= - weight*(dH[0]*(-vy)+dH[1]*vx)*(dbasis[0][i]*(-vy)+dbasis[1][i]*vx)*Jdet*gauss->weight;4988 for(i=0;i<numnodes;i++) pe->values[i]+= - weight*(dH[0]*(-vy)+dH[1]*vx)*(dbasis[0*numnodes+i]*(-vy)+dbasis[1*numnodes+i]*vx)*Jdet*gauss->weight; 4991 4989 break; 4992 4990 default: … … 4996 4994 4997 4995 /*Clean up and return*/ 4996 xDelete<IssmDouble>(basis); 4997 xDelete<IssmDouble>(dbasis); 4998 xDelete<int>(responses); 4998 4999 delete gauss; 4999 xDelete<int>(responses);5000 5000 return pe; 5001 5001 } … … 5874 5874 /*Fetch number of nodes and dof for this finite element*/ 5875 5875 int numnodes = this->NumberofNodes(); 5876 int numdof = numnodes*NDOF 2;5876 int numdof = numnodes*NDOF1; 5877 5877 5878 5878 /*Initialize Element matrix and vectors*/ … … 5928 5928 ElementMatrix* Tria::CreateKMatrixHydrologyDCEfficient(void){ 5929 5929 5930 /*constants: */5931 const int numdof=NDOF1*NUMVERTICES;5932 5933 5930 /* Intermediaries */ 5934 5931 IssmDouble D_scalar,Jdet; … … 5936 5933 IssmDouble epl_storing; 5937 5934 IssmDouble xyz_list[NUMVERTICES][3]; 5938 IssmDouble B[2][numdof];5939 IssmDouble basis[NUMVERTICES];5940 IssmDouble D[2][2];5941 GaussTria *gauss = NULL;5942 5935 5943 5936 /*Check that all nodes are active, else return empty matrix*/ … … 5946 5939 } 5947 5940 5948 /*Initialize Element matrix*/ 5949 ElementMatrix* Ke=new ElementMatrix(nodes,NUMVERTICES,this->parameters,NoneApproximationEnum); 5941 /*Fetch number of nodes and dof for this finite element*/ 5942 int numnodes = this->NumberofNodes(); 5943 int numdof = numnodes*NDOF1; 5944 5945 /*Initialize Element matrix and vectors*/ 5946 ElementMatrix* Ke = new ElementMatrix(nodes,numnodes,this->parameters); 5947 IssmDouble* B = xNew<IssmDouble>(5*numdof); 5948 IssmDouble* basis = xNew<IssmDouble>(numnodes); 5949 IssmDouble D[2][2]; 5950 5950 5951 5951 /*Retrieve all inputs and parameters*/ … … 5956 5956 5957 5957 /* Start looping on the number of gaussian points: */ 5958 gauss=new GaussTria(2);5958 GaussTria* gauss=new GaussTria(2); 5959 5959 for(int ig=gauss->begin();ig<gauss->end();ig++){ 5960 5960 … … 5967 5967 D[0][0]=D_scalar; D[0][1]=0.; 5968 5968 D[1][0]=0.; D[1][1]=D_scalar; 5969 GetBHydro( &B[0][0],&xyz_list[0][0],gauss);5970 TripleMultiply( &B[0][0],2,numdof,1,5969 GetBHydro(B,&xyz_list[0][0],gauss); 5970 TripleMultiply(B,2,numdof,1, 5971 5971 &D[0][0],2,2,0, 5972 &B[0][0],2,numdof,0,5972 B,2,numdof,0, 5973 5973 &Ke->values[0],1); 5974 5974 5975 5975 /*Transient*/ 5976 5976 if(reCast<bool,IssmDouble>(dt)){ 5977 GetNodalFunctions( &basis[0],gauss);5977 GetNodalFunctions(basis,gauss); 5978 5978 D_scalar=epl_storing*gauss->weight*Jdet; 5979 5979 5980 TripleMultiply( &basis[0],numdof,1,0,5980 TripleMultiply(basis,numdof,1,0, 5981 5981 &D_scalar,1,1,0, 5982 &basis[0],1,numdof,0,5982 basis,1,numdof,0, 5983 5983 &Ke->values[0],1); 5984 5984 } 5985 5985 } 5986 5986 5987 /*Clean up and return*/ 5988 xDelete<IssmDouble>(basis); 5989 xDelete<IssmDouble>(B); 5987 5990 delete gauss; 5988 5991 return Ke; … … 6734 6737 6735 6738 /*Clean up and return*/ 6739 xDelete<IssmDouble>(basis); 6736 6740 delete gauss; 6737 xDelete<IssmDouble>(basis);6738 6741 return pe; 6739 6742 } … … 6944 6947 ElementMatrix* Tria::CreateKMatrixBalancethickness_CG(void){ 6945 6948 6946 /*Constants*/6947 const int numdof=NDOF1*NUMVERTICES;6948 6949 6949 /*Intermediaries */ 6950 6950 int stabilization; 6951 6951 int i,j,dim; 6952 6952 IssmDouble Jdettria,vx,vy,dvxdx,dvydy,vel,h; 6953 IssmDouble D_scalar; 6953 6954 IssmDouble dvx[2],dvy[2]; 6954 6955 IssmDouble xyz_list[NUMVERTICES][3]; 6955 IssmDouble L[NUMVERTICES]; 6956 IssmDouble B[2][NUMVERTICES]; 6957 IssmDouble Bprime[2][NUMVERTICES]; 6958 IssmDouble K[2][2] = {0.0}; 6959 IssmDouble KDL[2][2] = {0.0}; 6960 IssmDouble DL[2][2] = {0.0}; 6961 IssmDouble DLprime[2][2] = {0.0}; 6962 IssmDouble DL_scalar; 6963 GaussTria *gauss = NULL; 6964 6965 /*Initialize Element matrix*/ 6966 ElementMatrix* Ke=new ElementMatrix(nodes,NUMVERTICES,this->parameters,NoneApproximationEnum); 6956 6957 /*Fetch number of nodes and dof for this finite element*/ 6958 int numnodes = this->NumberofNodes(); 6959 int numdof = numnodes*NDOF1; 6960 6961 /*Initialize Element matrix and vectors*/ 6962 ElementMatrix* Ke = new ElementMatrix(nodes,numnodes,this->parameters,NoneApproximationEnum); 6963 IssmDouble* basis = xNew<IssmDouble>(numnodes); 6964 IssmDouble* B = xNew<IssmDouble>(2*numdof); 6965 IssmDouble* Bprime = xNew<IssmDouble>(2*numdof); 6966 IssmDouble D[2][2]; 6967 6967 6968 6968 /*Retrieve all Inputs and parameters: */ … … 6983 6983 6984 6984 /*Start looping on the number of gaussian points:*/ 6985 gauss=new GaussTria(2);6985 GaussTria* gauss=new GaussTria(2); 6986 6986 for(int ig=gauss->begin();ig<gauss->end();ig++){ 6987 6987 … … 6989 6989 6990 6990 GetJacobianDeterminant(&Jdettria, &xyz_list[0][0],gauss); 6991 GetBPrognostic( &B[0][0], &xyz_list[0][0],gauss);6992 GetBprimePrognostic( &Bprime[0][0], &xyz_list[0][0],gauss);6991 GetBPrognostic(B,&xyz_list[0][0],gauss); 6992 GetBprimePrognostic(Bprime,&xyz_list[0][0],gauss); 6993 6993 6994 6994 vxaverage_input->GetInputValue(&vx,gauss); … … 6999 6999 dvxdx=dvx[0]; 7000 7000 dvydy=dvy[1]; 7001 DL_scalar=gauss->weight*Jdettria; 7002 7003 DL[0][0]=DL_scalar*dvxdx; 7004 DL[1][1]=DL_scalar*dvydy; 7005 7006 DLprime[0][0]=DL_scalar*vx; 7007 DLprime[1][1]=DL_scalar*vy; 7008 7009 TripleMultiply( &B[0][0],2,numdof,1, 7010 &DL[0][0],2,2,0, 7011 &B[0][0],2,numdof,0, 7001 D_scalar=gauss->weight*Jdettria; 7002 7003 D[0][0]=D_scalar*dvxdx; 7004 D[0][1]=0.; 7005 D[1][1]=D_scalar*dvydy; 7006 D[1][1]=0.; 7007 TripleMultiply(B,2,numdof,1, 7008 &D[0][0],2,2,0, 7009 B,2,numdof,0, 7012 7010 &Ke->values[0],1); 7013 7011 7014 TripleMultiply( &B[0][0],2,numdof,1, 7015 &DLprime[0][0],2,2,0, 7016 &Bprime[0][0],2,numdof,0, 7012 D[0][0]=D_scalar*vx; 7013 D[1][1]=D_scalar*vy; 7014 TripleMultiply(B,2,numdof,1, 7015 &D[0][0],2,2,0, 7016 Bprime,2,numdof,0, 7017 7017 &Ke->values[0],1); 7018 7018 … … 7020 7020 /*Streamline upwinding*/ 7021 7021 vel=sqrt(vx*vx+vy*vy); 7022 K[0][0]=h/(2*vel)*vx*vx;7023 K[1][0]=h/(2*vel)*vy*vx;7024 K[0][1]=h/(2*vel)*vx*vy;7025 K[1][1]=h/(2*vel)*vy*vy;7022 D[0][0]=h/(2*vel)*vx*vx; 7023 D[1][0]=h/(2*vel)*vy*vx; 7024 D[0][1]=h/(2*vel)*vx*vy; 7025 D[1][1]=h/(2*vel)*vy*vy; 7026 7026 } 7027 7027 else if(stabilization==2){ … … 7029 7029 vxaverage_input->GetInputAverage(&vx); 7030 7030 vyaverage_input->GetInputAverage(&vy); 7031 K[0][0]=h/2.0*fabs(vx);7032 K[0][1]=0.;7033 K[1][0]=0.;7034 K[1][1]=h/2.0*fabs(vy);7031 D[0][0]=h/2.0*fabs(vx); 7032 D[0][1]=0.; 7033 D[1][0]=0.; 7034 D[1][1]=h/2.0*fabs(vy); 7035 7035 } 7036 7036 if(stabilization==1 || stabilization==2){ 7037 KDL[0][0]=DL_scalar*K[0][0];7038 KDL[1][0]=DL_scalar*K[1][0];7039 KDL[0][1]=DL_scalar*K[0][1];7040 KDL[1][1]=DL_scalar*K[1][1];7041 TripleMultiply( &Bprime[0][0],2,numdof,1,7042 & KDL[0][0],2,2,0,7043 &Bprime[0][0],2,numdof,0,7037 D[0][0]=D_scalar*D[0][0]; 7038 D[1][0]=D_scalar*D[1][0]; 7039 D[0][1]=D_scalar*D[0][1]; 7040 D[1][1]=D_scalar*D[1][1]; 7041 TripleMultiply(Bprime,2,numdof,1, 7042 &D[0][0],2,2,0, 7043 Bprime,2,numdof,0, 7044 7044 &Ke->values[0],1); 7045 7045 } … … 7047 7047 7048 7048 /*Clean up and return*/ 7049 xDelete<IssmDouble>(basis); 7050 xDelete<IssmDouble>(B); 7051 xDelete<IssmDouble>(Bprime); 7049 7052 delete gauss; 7050 7053 return Ke; … … 7122 7125 ElementVector* Tria::CreatePVectorBalancethickness_CG(void){ 7123 7126 7124 /*Constants*/7125 const int numdof=NDOF1*NUMVERTICES;7126 7127 7127 /*Intermediaries */ 7128 int i,j;7129 7128 IssmDouble xyz_list[NUMVERTICES][3]; 7130 7129 IssmDouble dhdt_g,basal_melting_g,surface_mass_balance_g,Jdettria; 7131 IssmDouble basis[NUMVERTICES]; 7132 GaussTria* gauss=NULL; 7133 7134 /*Initialize Element vector*/ 7135 ElementVector* pe=new ElementVector(nodes,NUMVERTICES,this->parameters); 7130 7131 /*Fetch number of nodes and dof for this finite element*/ 7132 int numnodes = this->NumberofNodes(); 7133 int numdof = numnodes*NDOF1; 7134 7135 /*Initialize Element vector and other vectors*/ 7136 ElementVector* pe = new ElementVector(nodes,numnodes,this->parameters); 7137 IssmDouble* basis = xNew<IssmDouble>(numnodes); 7136 7138 7137 7139 /*Retrieve all inputs and parameters*/ … … 7142 7144 7143 7145 /* Start looping on the number of gaussian points: */ 7144 gauss=new GaussTria(2);7146 GaussTria* gauss=new GaussTria(2); 7145 7147 for(int ig=gauss->begin();ig<gauss->end();ig++){ 7146 7148 … … 7152 7154 7153 7155 GetJacobianDeterminant(&Jdettria, &xyz_list[0][0],gauss); 7154 GetNodalFunctions( &basis[0],gauss);7155 7156 for(i =0;i<numdof;i++) pe->values[i]+=Jdettria*gauss->weight*(surface_mass_balance_g-basal_melting_g-dhdt_g)*basis[i];7156 GetNodalFunctions(basis,gauss); 7157 7158 for(int i=0;i<numdof;i++) pe->values[i]+=Jdettria*gauss->weight*(surface_mass_balance_g-basal_melting_g-dhdt_g)*basis[i]; 7157 7159 } 7158 7160 7159 7161 /*Clean up and return*/ 7162 xDelete<IssmDouble>(basis); 7160 7163 delete gauss; 7161 7164 return pe;
Note:
See TracChangeset
for help on using the changeset viewer.