Changeset 26192
- Timestamp:
- 04/16/21 08:52:05 (4 years ago)
- Location:
- issm/trunk-jpl/src
- Files:
-
- 7 edited
Legend:
- Unmodified
- Added
- Removed
-
issm/trunk-jpl/src/c/analyses/StressbalanceAnalysis.cpp
r26187 r26192 194 194 } 195 195 } 196 else{//itapopo testinghere196 else{//itapopo FIXME only base velocities are constrained here 197 197 IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvx",StressbalanceAnalysisEnum,finiteelement,0); 198 IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvx",StressbalanceAnalysisEnum,finiteelement,1);198 //IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvx",StressbalanceAnalysisEnum,finiteelement,1); 199 199 if(iomodel->domaintype!=Domain2DverticalEnum){ 200 200 IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvy",StressbalanceAnalysisEnum,finiteelement,2); 201 IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvy",StressbalanceAnalysisEnum,finiteelement,3);201 //IoModelToConstraintsx(constraints,iomodel,"md.stressbalance.spcvy",StressbalanceAnalysisEnum,finiteelement,3); 202 202 } 203 203 } … … 783 783 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vx",VxEnum,0.); 784 784 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vy",VyEnum,0.); 785 if(isMLHO){//itapopo 786 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vx",Vx BaseEnum,0.);787 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vy",Vy BaseEnum,0.);785 if(isMLHO){//itapopo FIXME the shear velocities should be initialized correctly 786 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vx",VxShearEnum,0.); 787 iomodel->FetchDataToInput(inputs,elements,"md.initialization.vy",VyShearEnum,0.); 788 788 } 789 789 iomodel->FetchDataToInput(inputs,elements,"md.stressbalance.loadingforcex",LoadingforceXEnum); … … 2084 2084 /*Use the dof list to index into the solution vector: */ 2085 2085 for(i=0;i<numdof;i++) values[i]=solution[doflist[i]]; 2086 2086 2087 2087 /*Transform solution in Cartesian Space*/ 2088 2088 if(dim==2) basalelement->TransformSolutionCoord(&values[0],XYEnum); … … 2729 2729 /*MLHO*/ 2730 2730 ElementMatrix* StressbalanceAnalysis::CreateKMatrixMLHO(Element* element){/*{{{*/ 2731 2731 2732 _error_("Mono Layer Higher-Order called, not fully tested. If you are sure in using it, comment this line."); 2733 2732 2734 /* Check if ice in element */ 2733 2735 if(!element->IsIceInElement()) return NULL; … … 2745 2747 2746 2748 if(!element->IsOnBase() || element->IsFloating()) return NULL; 2749 2750 /*Intermediaries*/ 2751 int dim,domaintype; 2752 bool mainlyfloating; 2753 int friction_style,point1; 2754 IssmDouble alpha2,Jdet,fraction1,fraction2; 2755 IssmDouble gllevelset,phi=1.; 2756 IssmDouble *xyz_list = NULL; 2757 Gauss* gauss = NULL; 2758 2759 /*Get problem dimension*/ 2760 element->FindParam(&domaintype,DomainTypeEnum); 2761 switch(domaintype){ 2762 case Domain2DverticalEnum: dim = 1;break; 2763 case Domain2DhorizontalEnum: dim = 2;break; 2764 case Domain3DEnum: dim = 2;break; 2765 default: _error_("mesh "<<EnumToStringx(domaintype)<<" not supported yet"); 2766 } 2767 2768 /*Fetch number of nodes and dof for this finite element*/ 2769 int numnodes = element->GetNumberOfNodes(); 2770 int numdof = numnodes*dim; 2771 2772 /*Initialize Element matrix and vectors*/ 2773 ElementMatrix* Ke = element->NewElementMatrix(MLHOApproximationEnum); 2774 IssmDouble* basis = xNew<IssmDouble>(numnodes); 2775 2776 /*Retrieve all inputs and parameters*/ 2777 element->GetVerticesCoordinates(&xyz_list); 2778 element->FindParam(&friction_style,GroundinglineFrictionInterpolationEnum); 2779 Input* surface_input = element->GetInput(SurfaceEnum); _assert_(surface_input); 2780 Input* gllevelset_input = NULL; 2781 2782 /*build friction object, used later on: */ 2783 Friction* friction=new Friction(element,dim); 2784 2785 /*Recover portion of element that is grounded*/ 2786 if(!(friction_style==SubelementFriction2Enum)) phi=element->GetGroundedPortion(xyz_list); 2787 if(friction_style==SubelementFriction2Enum){ 2788 gllevelset_input=element->GetInput(MaskOceanLevelsetEnum); _assert_(gllevelset_input); 2789 element->GetGroundedPart(&point1,&fraction1,&fraction2,&mainlyfloating); 2790 gauss = element->NewGauss(point1,fraction1,fraction2,mainlyfloating,2); 2791 } 2792 else{ 2793 gauss = element->NewGauss(2); 2794 } 2747 2795 2796 /* Start looping on the number of gaussian points: */ 2797 while(gauss->next()){ 2798 2799 friction->GetAlpha2(&alpha2,gauss); 2800 if(friction_style==SubelementFriction1Enum) alpha2=phi*alpha2; 2801 else if(friction_style==SubelementFriction2Enum){ 2802 gllevelset_input->GetInputValue(&gllevelset, gauss); 2803 if(gllevelset<0.) alpha2=0.; 2804 } 2805 else if(friction_style==NoFrictionOnPartiallyFloatingEnum){ 2806 if (phi<0.99999999) alpha2=0.; 2807 } 2808 else _error_("friction interpolation "<<EnumToStringx(friction_style)<<" not implemented yet"); 2809 2810 element->NodalFunctions(basis,gauss); 2811 element->JacobianDeterminant(&Jdet, xyz_list,gauss); 2812 2813 for(int i=0;i<numnodes;i++){ 2814 for(int j=0;j<numnodes;j++){ 2815 Ke->values[(4*i+0)*2*2*numnodes+4*j+0] += alpha2*gauss->weight*Jdet*basis[i]*basis[j]; 2816 Ke->values[(4*i+2)*2*2*numnodes+4*j+2] += alpha2*gauss->weight*Jdet*basis[i]*basis[j]; 2817 } 2818 } 2819 } 2820 2821 /*Clean up and return*/ 2822 delete gauss; 2823 delete friction; 2824 xDelete<IssmDouble>(xyz_list); 2825 xDelete<IssmDouble>(basis); 2826 return Ke; 2827 2828 2829 //itapopo OLD - testing above 2748 2830 /*Intermediaries*/ 2749 int domaintype;2831 //int domaintype; 2750 2832 Element* basalelement; 2751 2833 … … 2764 2846 2765 2847 //Element* basalelement = element->SpawnBasalElement(); 2766 ElementMatrix* Ke = basalelement->NewElementMatrix(MLHOApproximationEnum);2848 //ElementMatrix* Ke = basalelement->NewElementMatrix(MLHOApproximationEnum); 2767 2849 ElementMatrix* KeSSA = CreateKMatrixSSAFriction(basalelement); //only to get K11 and K33 2768 2850 2769 2851 /*Fetch number of nodes and dof for this finite element*/ 2770 int numnodes = basalelement->GetNumberOfNodes();2852 //int numnodes = basalelement->GetNumberOfNodes(); 2771 2853 2772 2854 for(int i=0;i<numnodes;i++){ … … 2776 2858 } 2777 2859 } 2778 2860 2861 KeSSA->Echo(); 2862 Ke->Echo(); 2863 _error_("mesh "); 2864 2779 2865 /*Transform Coordinate System*/ 2780 2866 //basalelement->TransformStiffnessMatrixCoord(Ke,XYMLHOEnum); … … 2831 2917 gauss->SynchronizeGaussBase(gauss_base); 2832 2918 2833 element->JacobianDeterminant(&Jdet,xyz_list,gauss );2919 element->JacobianDeterminant(&Jdet,xyz_list,gauss_base); 2834 2920 basalelement->NodalFunctionsDerivatives(dbasis,xyz_list,gauss_base); 2835 element->NodalFunctions(basis, gauss);2921 basalelement->NodalFunctions(basis, gauss_base); 2836 2922 2837 2923 thickness_input->GetInputValue(&thickness, gauss); 2838 2924 n_input->GetInputValue(&n,gauss); 2925 //FIXME testing with L1L2-type viscosity 2839 2926 element->material->ViscosityL1L2(&viscosity,xyz_list,gauss,vx_input,vy_input,surface_input); 2840 //viscosity=10e1 0;//itapopo2927 //viscosity=10e13;//itapopo 2841 2928 2842 2929 for(int i=0;i<numnodes;i++){//shape functions on tria element … … 3040 3127 base_under_water = min(0.,base-sealevel); // 0 if the bottom of the glacier is above water level 3041 3128 /*Vertically integrated pressure - SSA type*/ 3042 water_pressure = 1.0/2.0*gravity*rho_water*(surface_under_water*surface_under_water - base_under_water*base_under_water);3043 ice_pressure = 1.0/2.0*gravity*rho_ice*thickness*thickness;3129 water_pressure = (1.0/2.0)*gravity*rho_water*(surface_under_water*surface_under_water - base_under_water*base_under_water); 3130 ice_pressure = (1.0/2.0)*gravity*rho_ice*thickness*thickness; 3044 3131 pressure = ice_pressure + water_pressure; 3045 3132 /*Vertically integrated pressure - HO type*/ 3046 3133 b=min(0.,base-sealevel); // 0 if the bottom of the glacier is above water level 3047 3134 s=thickness+b; // ice surface regardless of whether the top of the glacier is above water level or not 3048 water_pressure_sh = gravity*rho_water*( -b*b/2 + pow(-b,n+2)*( -s/(n+2) -b/(n+3) )/pow(thickness,n+1));3135 water_pressure_sh = gravity*rho_water*( -b*b/2 + (pow(-b,n+2)/pow(thickness,n+1))*(-s/(n+2)-b/(n+3)) ); 3049 3136 ice_pressure_sh = gravity*rho_ice*thickness*thickness*(n+1)/(2*(n+3)); 3050 3137 pressure_sh = ice_pressure_sh + water_pressure_sh; … … 3131 3218 for(i=0;i<numdof;i++) values[i]=solution[doflist[i]]; 3132 3219 3133 std::cout<<"******** Element ID="<<element->Id()<<"\n";3134 for(i=0;i<numdof;i++){3135 std::cout<<values[i]<<"\n";3136 }3220 //std::cout<<"MLHO ******** Element ID="<<element->Id()<<"\n"; 3221 //for(i=0;i<numdof;i++){ 3222 // std::cout<<values[i]*31536000<<"\n"; 3223 //} 3137 3224 3138 3225 /*Transform solution in Cartesian Space*/ … … 3142 3229 /*Ok, we have vx and vy in values, fill in vx and vy arrays: */ 3143 3230 for(i=0;i<numnodes;i++){ //numnodes of the 2D mesh in which the MLHO is written 3144 vx[i] =values[i*4+0]; //bas alvx3145 vshx[i]=values[i*4+1]; 3231 vx[i] =values[i*4+0]; //base vx 3232 vshx[i]=values[i*4+1]; //shear vx 3146 3233 if(xIsNan<IssmDouble>(vx[i])) _error_("NaN found in solution vector"); 3147 3234 if(xIsInf<IssmDouble>(vx[i])) _error_("Inf found in solution vector"); 3148 3235 if(xIsNan<IssmDouble>(vshx[i])) _error_("NaN found in solution vector"); 3149 3236 if(xIsInf<IssmDouble>(vshx[i])) _error_("Inf found in solution vector"); 3150 //if(dim==3){ 3151 vy[i] =values[i*4+2]; //basal vy 3152 vshy[i]=values[i*4+3]; 3153 if(xIsNan<IssmDouble>(vy[i])) _error_("NaN found in solution vector"); 3154 if(xIsInf<IssmDouble>(vy[i])) _error_("Inf found in solution vector"); 3155 if(xIsNan<IssmDouble>(vshy[i])) _error_("NaN found in solution vector"); 3156 if(xIsInf<IssmDouble>(vshy[i])) _error_("Inf found in solution vector"); 3157 //} 3158 } 3159 3160 /*Add vx and vy as inputs to the tria element (basal velocities): */ 3161 element->AddBasalInput(VxBaseEnum,vx,element->GetElementType()); 3162 element->AddBasalInput(VyBaseEnum,vy,element->GetElementType()); 3163 3164 /*Compute suface velocities vx and vy*/ 3165 if(domaintype==Domain2DhorizontalEnum) { 3166 for(i=0;i<numnodes;i++) vx[i]=vx[i]+vshx[i]; 3167 for(i=0;i<numnodes;i++) vy[i]=vy[i]+vshy[i]; 3168 } 3169 3170 /*Get Vz and compute vel (surface)*/ 3237 vy[i] =values[i*4+2]; //base vy 3238 vshy[i]=values[i*4+3]; //shear vy 3239 if(xIsNan<IssmDouble>(vy[i])) _error_("NaN found in solution vector"); 3240 if(xIsInf<IssmDouble>(vy[i])) _error_("Inf found in solution vector"); 3241 if(xIsNan<IssmDouble>(vshy[i])) _error_("NaN found in solution vector"); 3242 if(xIsInf<IssmDouble>(vshy[i])) _error_("Inf found in solution vector"); 3243 } 3244 3245 /*Add vx and vy as inputs to the tria element (shear velocities): */ 3246 element->AddBasalInput(VxShearEnum,vshx,element->GetElementType()); 3247 element->AddBasalInput(VyShearEnum,vshy,element->GetElementType()); 3248 3249 /*Get Vz and compute vel (base)*/ 3171 3250 basalelement->GetInputListOnNodes(&vz[0],VzEnum,0.); 3172 3251 for(i=0;i<numnodes;i++) vel[i]=sqrt(vx[i]*vx[i] + vy[i]*vy[i] + vz[i]*vz[i]); 3173 3252 3174 /*Add vx and vy as inputs to the tria element surface velocities): */3253 /*Add vx and vy as inputs to the tria element (base velocities): */ 3175 3254 element->AddBasalInput(VxEnum,vx,element->GetElementType()); 3176 3255 element->AddBasalInput(VyEnum,vy,element->GetElementType()); … … 3191 3270 void StressbalanceAnalysis::GetSolutionFromInputsMLHO(Vector<IssmDouble>* solution,Element* element){/*{{{*/ 3192 3271 3193 IssmDouble vx,vy,v bx,vby;3272 IssmDouble vx,vy,vshx,vshy; 3194 3273 int domaintype,dim,approximation,dofpernode; 3195 3274 int* doflist = NULL; … … 3215 3294 /*Get inputs*/ 3216 3295 Input* vx_input =element->GetInput(VxEnum); _assert_(vx_input); 3217 Input* vxbase_input =element->GetInput(VxBaseEnum); _assert_(vxbase_input); 3218 Input* vy_input =NULL; 3219 Input* vybase_input =NULL; 3220 if(domaintype!=Domain2DverticalEnum){ 3221 vy_input =element->GetInput(VyEnum); _assert_(vy_input); 3222 vybase_input=element->GetInput(VyBaseEnum); _assert_(vybase_input); 3223 } 3296 Input* vxshear_input =element->GetInput(VxShearEnum); _assert_(vxshear_input); 3297 Input* vy_input =element->GetInput(VyEnum); _assert_(vy_input); 3298 Input* vyshear_input =element->GetInput(VyShearEnum); _assert_(vyshear_input); 3224 3299 3225 3300 /*Ok, we have vx and vy in values, fill in vx and vy arrays: */ … … 3229 3304 3230 3305 /*Recover vx and vy*/ 3231 vx_input->GetInputValue(&vx,gauss); 3232 vxbase_input->GetInputValue(&vbx,gauss); 3233 values[i*4+0]=vbx; //basal vx 3234 values[i*4+1]=vx-vbx; //shear vx 3235 //if(dofpernode==2){ 3236 vy_input->GetInputValue(&vy,gauss); 3237 vybase_input->GetInputValue(&vby,gauss); 3238 values[i*4+2]=vby; //basal vy 3239 values[i*4+3]=vy-vby; //shear vy 3240 //} 3306 vx_input->GetInputValue(&vx,gauss); //base vx 3307 vxshear_input->GetInputValue(&vshx,gauss);//shear vx 3308 values[i*4+0]=vx; //base vx 3309 values[i*4+1]=vshx; //shear vx 3310 vy_input->GetInputValue(&vy,gauss); //base vy 3311 vyshear_input->GetInputValue(&vshy,gauss);//shear vy 3312 values[i*4+2]=vy; //base vy 3313 values[i*4+3]=vshy;//shear vy 3241 3314 } 3242 3315 -
issm/trunk-jpl/src/c/shared/Enum/Enum.vim
r26165 r26192 935 935 syn keyword cConstant VelEnum 936 936 syn keyword cConstant VxAverageEnum 937 syn keyword cConstant VxBaseEnum938 937 syn keyword cConstant VxEnum 939 938 syn keyword cConstant VxMeshEnum 940 939 syn keyword cConstant VxObsEnum 940 syn keyword cConstant VxShearEnum 941 941 syn keyword cConstant VyAverageEnum 942 syn keyword cConstant VyBaseEnum943 942 syn keyword cConstant VyEnum 944 943 syn keyword cConstant VyMeshEnum 945 944 syn keyword cConstant VyObsEnum 945 syn keyword cConstant VyShearEnum 946 946 syn keyword cConstant VzEnum 947 947 syn keyword cConstant VzFSEnum … … 1451 1451 syn keyword cType Cfsurfacesquare 1452 1452 syn keyword cType Channel 1453 syn keyword cType classes 1453 1454 syn keyword cType Constraint 1454 1455 syn keyword cType Constraints … … 1457 1458 syn keyword cType ControlInput 1458 1459 syn keyword cType Covertree 1460 syn keyword cType DatasetInput 1459 1461 syn keyword cType DataSetParam 1460 syn keyword cType DatasetInput1461 1462 syn keyword cType Definition 1462 1463 syn keyword cType DependentObject … … 1471 1472 syn keyword cType ElementInput 1472 1473 syn keyword cType ElementMatrix 1474 syn keyword cType Elements 1473 1475 syn keyword cType ElementVector 1474 syn keyword cType Elements1475 1476 syn keyword cType ExponentialVariogram 1476 1477 syn keyword cType ExternalResult … … 1479 1480 syn keyword cType Friction 1480 1481 syn keyword cType Gauss 1482 syn keyword cType GaussianVariogram 1483 syn keyword cType gaussobjects 1481 1484 syn keyword cType GaussPenta 1482 1485 syn keyword cType GaussSeg 1483 1486 syn keyword cType GaussTetra 1484 1487 syn keyword cType GaussTria 1485 syn keyword cType GaussianVariogram1486 1488 syn keyword cType GenericExternalResult 1487 1489 syn keyword cType GenericOption … … 1498 1500 syn keyword cType IssmDirectApplicInterface 1499 1501 syn keyword cType IssmParallelDirectApplicInterface 1502 syn keyword cType krigingobjects 1500 1503 syn keyword cType Load 1501 1504 syn keyword cType Loads … … 1508 1511 syn keyword cType Matice 1509 1512 syn keyword cType Matlitho 1513 syn keyword cType matrixobjects 1510 1514 syn keyword cType MatrixParam 1511 1515 syn keyword cType Misfit … … 1520 1524 syn keyword cType Observations 1521 1525 syn keyword cType Option 1526 syn keyword cType Options 1522 1527 syn keyword cType OptionUtilities 1523 syn keyword cType Options1524 1528 syn keyword cType Param 1525 1529 syn keyword cType Parameters … … 1535 1539 syn keyword cType Regionaloutput 1536 1540 syn keyword cType Results 1541 syn keyword cType Riftfront 1537 1542 syn keyword cType RiftStruct 1538 syn keyword cType Riftfront1539 1543 syn keyword cType SealevelMasks 1540 1544 syn keyword cType Seg 1541 1545 syn keyword cType SegInput 1546 syn keyword cType Segment 1542 1547 syn keyword cType SegRef 1543 syn keyword cType Segment1544 1548 syn keyword cType SpcDynamic 1545 1549 syn keyword cType SpcStatic … … 1560 1564 syn keyword cType Vertex 1561 1565 syn keyword cType Vertices 1562 syn keyword cType classes1563 syn keyword cType gaussobjects1564 syn keyword cType krigingobjects1565 syn keyword cType matrixobjects1566 1566 syn keyword cType AdjointBalancethickness2Analysis 1567 1567 syn keyword cType AdjointBalancethicknessAnalysis -
issm/trunk-jpl/src/c/shared/Enum/EnumDefinitions.h
r26165 r26192 932 932 VelEnum, 933 933 VxAverageEnum, 934 VxBaseEnum,935 934 VxEnum, 936 935 VxMeshEnum, 937 936 VxObsEnum, 937 VxShearEnum, 938 938 VyAverageEnum, 939 VyBaseEnum,940 939 VyEnum, 941 940 VyMeshEnum, 942 941 VyObsEnum, 942 VyShearEnum, 943 943 VzEnum, 944 944 VzFSEnum, -
issm/trunk-jpl/src/c/shared/Enum/EnumToStringx.cpp
r26165 r26192 937 937 case VelEnum : return "Vel"; 938 938 case VxAverageEnum : return "VxAverage"; 939 case VxBaseEnum : return "VxBase";940 939 case VxEnum : return "Vx"; 941 940 case VxMeshEnum : return "VxMesh"; 942 941 case VxObsEnum : return "VxObs"; 942 case VxShearEnum : return "VxShear"; 943 943 case VyAverageEnum : return "VyAverage"; 944 case VyBaseEnum : return "VyBase";945 944 case VyEnum : return "Vy"; 946 945 case VyMeshEnum : return "VyMesh"; 947 946 case VyObsEnum : return "VyObs"; 947 case VyShearEnum : return "VyShear"; 948 948 case VzEnum : return "Vz"; 949 949 case VzFSEnum : return "VzFS"; -
issm/trunk-jpl/src/c/shared/Enum/StringToEnumx.cpp
r26165 r26192 958 958 else if (strcmp(name,"Vel")==0) return VelEnum; 959 959 else if (strcmp(name,"VxAverage")==0) return VxAverageEnum; 960 else if (strcmp(name,"VxBase")==0) return VxBaseEnum;961 960 else if (strcmp(name,"Vx")==0) return VxEnum; 962 961 else if (strcmp(name,"VxMesh")==0) return VxMeshEnum; 963 962 else if (strcmp(name,"VxObs")==0) return VxObsEnum; 963 else if (strcmp(name,"VxShear")==0) return VxShearEnum; 964 964 else if (strcmp(name,"VyAverage")==0) return VyAverageEnum; 965 else if (strcmp(name,"VyBase")==0) return VyBaseEnum;966 965 else if (strcmp(name,"Vy")==0) return VyEnum; 967 966 else if (strcmp(name,"VyMesh")==0) return VyMeshEnum; 968 967 else if (strcmp(name,"VyObs")==0) return VyObsEnum; 968 else if (strcmp(name,"VyShear")==0) return VyShearEnum; 969 969 else if (strcmp(name,"Vz")==0) return VzEnum; 970 970 else if (strcmp(name,"VzFS")==0) return VzFSEnum; -
issm/trunk-jpl/src/m/classes/flowequation.m
r25688 r26192 122 122 md = checkfield(md,'fieldname','flowequation.borderFS','size',[md.mesh.numberofvertices 1],'values',[0 1]); 123 123 if strcmp(domaintype(md.mesh),'2Dhorizontal') 124 md = checkfield(md,'fieldname','flowequation.vertex_equation','size',[md.mesh.numberofvertices 1],'values',[1 :2]);125 md = checkfield(md,'fieldname','flowequation.element_equation','size',[md.mesh.numberofelements 1],'values',[1 :2]);124 md = checkfield(md,'fieldname','flowequation.vertex_equation','size',[md.mesh.numberofvertices 1],'values',[1,2,4]); 125 md = checkfield(md,'fieldname','flowequation.element_equation','size',[md.mesh.numberofelements 1],'values',[1,2,4]); 126 126 elseif strcmp(domaintype(md.mesh),'3Dsurface') 127 127 md = checkfield(md,'fieldname','flowequation.vertex_equation','size',[md.mesh.numberofvertices 1],'values',[1:2]); -
issm/trunk-jpl/src/m/solve/parseresultsfromdisk.m
r25714 r26192 224 224 field = field*yts; 225 225 elseif strcmp(fieldname,'Vel'), 226 field = field*yts; 227 elseif strcmp(fieldname,'VxShear'), 228 field = field*yts; 229 elseif strcmp(fieldname,'VyShear'), 226 230 field = field*yts; 227 231 elseif strcmp(fieldname,'BasalforcingsGroundediceMeltingRate'),
Note:
See TracChangeset
for help on using the changeset viewer.